├── .gitignore ├── FaceRelighting.sln ├── FaceRelighting.vcxproj ├── FaceRelighting.vcxproj.filters ├── FaceRelighting.vcxproj.user ├── LICENSE ├── data ├── BFM │ └── convert.py ├── classifiers │ ├── haarcascade_frontalface_alt.xml │ ├── haarcascade_frontalface_alt2.xml │ ├── haarcascade_frontalface_alt_tree.xml │ ├── haarcascade_frontalface_default.xml │ └── haarcascade_profileface.xml ├── example │ ├── image.png │ └── me.jpg └── model │ ├── clm_general.txt │ ├── clm_wild.txt │ ├── clnf_general.txt │ ├── clnf_wild.txt │ ├── detection_validation │ ├── validator_cnn.txt │ └── validator_general_68.txt │ ├── haarAlign.txt │ ├── main_clm_general.txt │ ├── main_clm_wild.txt │ ├── main_clnf_general.txt │ ├── main_clnf_wild.txt │ ├── model_eye │ ├── clnf_left_synth.txt │ ├── clnf_right_synth.txt │ ├── main_clnf_synth_left.txt │ ├── main_clnf_synth_right.txt │ ├── patch_experts │ │ ├── ccnf_patches_1.00_synth_lid_.txt │ │ ├── ccnf_patches_1.50_synth_lid_.txt │ │ ├── left_ccnf_patches_1.00_synth_lid_.txt │ │ └── left_ccnf_patches_1.50_synth_lid_.txt │ └── pdms │ │ ├── pdm_28_eye_3D_closed.txt │ │ └── pdm_28_l_eye_3D_closed.txt │ ├── model_inner │ ├── clnf_inner.txt │ ├── main_clnf_inner.txt │ ├── patch_experts │ │ └── ccnf_patches_1.00_inner.txt │ └── pdms │ │ └── pdm_51_inner.txt │ ├── patch_experts │ ├── ccnf_patches_0.25_general.txt │ ├── ccnf_patches_0.25_wild.txt │ ├── ccnf_patches_0.35_general.txt │ ├── ccnf_patches_0.35_wild.txt │ ├── ccnf_patches_0.5_general.txt │ ├── ccnf_patches_0.5_wild.txt │ ├── ccnf_patches_1_wild.txt │ ├── svr_patches_0.25_general.txt │ ├── svr_patches_0.25_wild.txt │ ├── svr_patches_0.35_general.txt │ ├── svr_patches_0.35_wild.txt │ ├── svr_patches_0.5_general.txt │ └── svr_patches_0.5_wild.txt │ ├── pdms │ ├── In-the-wild_aligned_PDM_68.txt │ └── Multi-PIE_aligned_PDM_68.txt │ ├── tris_68.txt │ └── tris_68_full.txt ├── documentation └── documentation.pdf ├── include ├── BFM.cpp ├── BFM.h ├── BFM2Pixel.cpp ├── BFM2Pixel.h ├── Eigen │ ├── CMakeLists.txt │ ├── Cholesky │ ├── CholmodSupport │ ├── Core │ ├── Dense │ ├── Eigen │ ├── Eigenvalues │ ├── Geometry │ ├── Householder │ ├── IterativeLinearSolvers │ ├── Jacobi │ ├── LU │ ├── MetisSupport │ ├── OrderingMethods │ ├── PaStiXSupport │ ├── PardisoSupport │ ├── QR │ ├── QtAlignedMalloc │ ├── SPQRSupport │ ├── SVD │ ├── Sparse │ ├── SparseCholesky │ ├── SparseCore │ ├── SparseLU │ ├── SparseQR │ ├── StdDeque │ ├── StdList │ ├── StdVector │ ├── SuperLUSupport │ ├── UmfPackSupport │ └── src │ │ ├── Cholesky │ │ ├── LDLT.h │ │ ├── LLT.h │ │ └── LLT_LAPACKE.h │ │ ├── CholmodSupport │ │ └── CholmodSupport.h │ │ ├── Core │ │ ├── Array.h │ │ ├── ArrayBase.h │ │ ├── ArrayWrapper.h │ │ ├── Assign.h │ │ ├── AssignEvaluator.h │ │ ├── Assign_MKL.h │ │ ├── BandMatrix.h │ │ ├── Block.h │ │ ├── BooleanRedux.h │ │ ├── CommaInitializer.h │ │ ├── ConditionEstimator.h │ │ ├── CoreEvaluators.h │ │ ├── CoreIterators.h │ │ ├── CwiseBinaryOp.h │ │ ├── CwiseNullaryOp.h │ │ ├── CwiseTernaryOp.h │ │ ├── CwiseUnaryOp.h │ │ ├── CwiseUnaryView.h │ │ ├── DenseBase.h │ │ ├── DenseCoeffsBase.h │ │ ├── DenseStorage.h │ │ ├── Diagonal.h │ │ ├── DiagonalMatrix.h │ │ ├── DiagonalProduct.h │ │ ├── Dot.h │ │ ├── EigenBase.h │ │ ├── ForceAlignedAccess.h │ │ ├── Fuzzy.h │ │ ├── GeneralProduct.h │ │ ├── GenericPacketMath.h │ │ ├── GlobalFunctions.h │ │ ├── IO.h │ │ ├── Inverse.h │ │ ├── Map.h │ │ ├── MapBase.h │ │ ├── MathFunctions.h │ │ ├── MathFunctionsImpl.h │ │ ├── Matrix.h │ │ ├── MatrixBase.h │ │ ├── NestByValue.h │ │ ├── NoAlias.h │ │ ├── NumTraits.h │ │ ├── PermutationMatrix.h │ │ ├── PlainObjectBase.h │ │ ├── Product.h │ │ ├── ProductEvaluators.h │ │ ├── Random.h │ │ ├── Redux.h │ │ ├── Ref.h │ │ ├── Replicate.h │ │ ├── ReturnByValue.h │ │ ├── Reverse.h │ │ ├── Select.h │ │ ├── SelfAdjointView.h │ │ ├── SelfCwiseBinaryOp.h │ │ ├── Solve.h │ │ ├── SolveTriangular.h │ │ ├── SolverBase.h │ │ ├── StableNorm.h │ │ ├── Stride.h │ │ ├── Swap.h │ │ ├── Transpose.h │ │ ├── Transpositions.h │ │ ├── TriangularMatrix.h │ │ ├── VectorBlock.h │ │ ├── VectorwiseOp.h │ │ ├── Visitor.h │ │ ├── arch │ │ │ ├── AVX │ │ │ │ ├── Complex.h │ │ │ │ ├── MathFunctions.h │ │ │ │ ├── PacketMath.h │ │ │ │ └── TypeCasting.h │ │ │ ├── AVX512 │ │ │ │ ├── MathFunctions.h │ │ │ │ └── PacketMath.h │ │ │ ├── AltiVec │ │ │ │ ├── Complex.h │ │ │ │ ├── MathFunctions.h │ │ │ │ └── PacketMath.h │ │ │ ├── CUDA │ │ │ │ ├── Complex.h │ │ │ │ ├── Half.h │ │ │ │ ├── MathFunctions.h │ │ │ │ ├── PacketMath.h │ │ │ │ ├── PacketMathHalf.h │ │ │ │ └── TypeCasting.h │ │ │ ├── Default │ │ │ │ └── Settings.h │ │ │ ├── NEON │ │ │ │ ├── Complex.h │ │ │ │ ├── MathFunctions.h │ │ │ │ └── PacketMath.h │ │ │ ├── SSE │ │ │ │ ├── Complex.h │ │ │ │ ├── MathFunctions.h │ │ │ │ ├── PacketMath.h │ │ │ │ └── TypeCasting.h │ │ │ └── ZVector │ │ │ │ ├── Complex.h │ │ │ │ ├── MathFunctions.h │ │ │ │ └── PacketMath.h │ │ ├── functors │ │ │ ├── AssignmentFunctors.h │ │ │ ├── BinaryFunctors.h │ │ │ ├── NullaryFunctors.h │ │ │ ├── StlFunctors.h │ │ │ ├── TernaryFunctors.h │ │ │ └── UnaryFunctors.h │ │ ├── products │ │ │ ├── GeneralBlockPanelKernel.h │ │ │ ├── GeneralMatrixMatrix.h │ │ │ ├── GeneralMatrixMatrixTriangular.h │ │ │ ├── GeneralMatrixMatrixTriangular_BLAS.h │ │ │ ├── GeneralMatrixMatrix_BLAS.h │ │ │ ├── GeneralMatrixVector.h │ │ │ ├── GeneralMatrixVector_BLAS.h │ │ │ ├── Parallelizer.h │ │ │ ├── SelfadjointMatrixMatrix.h │ │ │ ├── SelfadjointMatrixMatrix_BLAS.h │ │ │ ├── SelfadjointMatrixVector.h │ │ │ ├── SelfadjointMatrixVector_BLAS.h │ │ │ ├── SelfadjointProduct.h │ │ │ ├── SelfadjointRank2Update.h │ │ │ ├── TriangularMatrixMatrix.h │ │ │ ├── TriangularMatrixMatrix_BLAS.h │ │ │ ├── TriangularMatrixVector.h │ │ │ ├── TriangularMatrixVector_BLAS.h │ │ │ ├── TriangularSolverMatrix.h │ │ │ ├── TriangularSolverMatrix_BLAS.h │ │ │ └── TriangularSolverVector.h │ │ └── util │ │ │ ├── BlasUtil.h │ │ │ ├── Constants.h │ │ │ ├── DisableStupidWarnings.h │ │ │ ├── ForwardDeclarations.h │ │ │ ├── MKL_support.h │ │ │ ├── Macros.h │ │ │ ├── Memory.h │ │ │ ├── Meta.h │ │ │ ├── NonMPL2.h │ │ │ ├── ReenableStupidWarnings.h │ │ │ ├── StaticAssert.h │ │ │ └── XprHelper.h │ │ ├── Eigenvalues │ │ ├── ComplexEigenSolver.h │ │ ├── ComplexSchur.h │ │ ├── ComplexSchur_LAPACKE.h │ │ ├── EigenSolver.h │ │ ├── GeneralizedEigenSolver.h │ │ ├── GeneralizedSelfAdjointEigenSolver.h │ │ ├── HessenbergDecomposition.h │ │ ├── MatrixBaseEigenvalues.h │ │ ├── RealQZ.h │ │ ├── RealSchur.h │ │ ├── RealSchur_LAPACKE.h │ │ ├── SelfAdjointEigenSolver.h │ │ ├── SelfAdjointEigenSolver_LAPACKE.h │ │ └── Tridiagonalization.h │ │ ├── Geometry │ │ ├── AlignedBox.h │ │ ├── AngleAxis.h │ │ ├── EulerAngles.h │ │ ├── Homogeneous.h │ │ ├── Hyperplane.h │ │ ├── OrthoMethods.h │ │ ├── ParametrizedLine.h │ │ ├── Quaternion.h │ │ ├── Rotation2D.h │ │ ├── RotationBase.h │ │ ├── Scaling.h │ │ ├── Transform.h │ │ ├── Translation.h │ │ ├── Umeyama.h │ │ └── arch │ │ │ └── Geometry_SSE.h │ │ ├── Householder │ │ ├── BlockHouseholder.h │ │ ├── Householder.h │ │ └── HouseholderSequence.h │ │ ├── IterativeLinearSolvers │ │ ├── BasicPreconditioners.h │ │ ├── BiCGSTAB.h │ │ ├── ConjugateGradient.h │ │ ├── IncompleteCholesky.h │ │ ├── IncompleteLUT.h │ │ ├── IterativeSolverBase.h │ │ ├── LeastSquareConjugateGradient.h │ │ └── SolveWithGuess.h │ │ ├── Jacobi │ │ └── Jacobi.h │ │ ├── LU │ │ ├── Determinant.h │ │ ├── FullPivLU.h │ │ ├── InverseImpl.h │ │ ├── PartialPivLU.h │ │ ├── PartialPivLU_LAPACKE.h │ │ └── arch │ │ │ └── Inverse_SSE.h │ │ ├── MetisSupport │ │ └── MetisSupport.h │ │ ├── OrderingMethods │ │ ├── Amd.h │ │ ├── Eigen_Colamd.h │ │ └── Ordering.h │ │ ├── PaStiXSupport │ │ └── PaStiXSupport.h │ │ ├── PardisoSupport │ │ └── PardisoSupport.h │ │ ├── QR │ │ ├── ColPivHouseholderQR.h │ │ ├── ColPivHouseholderQR_LAPACKE.h │ │ ├── CompleteOrthogonalDecomposition.h │ │ ├── FullPivHouseholderQR.h │ │ ├── HouseholderQR.h │ │ └── HouseholderQR_LAPACKE.h │ │ ├── SPQRSupport │ │ └── SuiteSparseQRSupport.h │ │ ├── SVD │ │ ├── BDCSVD.h │ │ ├── JacobiSVD.h │ │ ├── JacobiSVD_LAPACKE.h │ │ ├── SVDBase.h │ │ └── UpperBidiagonalization.h │ │ ├── SparseCholesky │ │ ├── SimplicialCholesky.h │ │ └── SimplicialCholesky_impl.h │ │ ├── SparseCore │ │ ├── AmbiVector.h │ │ ├── CompressedStorage.h │ │ ├── ConservativeSparseSparseProduct.h │ │ ├── MappedSparseMatrix.h │ │ ├── SparseAssign.h │ │ ├── SparseBlock.h │ │ ├── SparseColEtree.h │ │ ├── SparseCompressedBase.h │ │ ├── SparseCwiseBinaryOp.h │ │ ├── SparseCwiseUnaryOp.h │ │ ├── SparseDenseProduct.h │ │ ├── SparseDiagonalProduct.h │ │ ├── SparseDot.h │ │ ├── SparseFuzzy.h │ │ ├── SparseMap.h │ │ ├── SparseMatrix.h │ │ ├── SparseMatrixBase.h │ │ ├── SparsePermutation.h │ │ ├── SparseProduct.h │ │ ├── SparseRedux.h │ │ ├── SparseRef.h │ │ ├── SparseSelfAdjointView.h │ │ ├── SparseSolverBase.h │ │ ├── SparseSparseProductWithPruning.h │ │ ├── SparseTranspose.h │ │ ├── SparseTriangularView.h │ │ ├── SparseUtil.h │ │ ├── SparseVector.h │ │ ├── SparseView.h │ │ └── TriangularSolver.h │ │ ├── SparseLU │ │ ├── SparseLU.h │ │ ├── SparseLUImpl.h │ │ ├── SparseLU_Memory.h │ │ ├── SparseLU_Structs.h │ │ ├── SparseLU_SupernodalMatrix.h │ │ ├── SparseLU_Utils.h │ │ ├── SparseLU_column_bmod.h │ │ ├── SparseLU_column_dfs.h │ │ ├── SparseLU_copy_to_ucol.h │ │ ├── SparseLU_gemm_kernel.h │ │ ├── SparseLU_heap_relax_snode.h │ │ ├── SparseLU_kernel_bmod.h │ │ ├── SparseLU_panel_bmod.h │ │ ├── SparseLU_panel_dfs.h │ │ ├── SparseLU_pivotL.h │ │ ├── SparseLU_pruneL.h │ │ └── SparseLU_relax_snode.h │ │ ├── SparseQR │ │ └── SparseQR.h │ │ ├── StlSupport │ │ ├── StdDeque.h │ │ ├── StdList.h │ │ ├── StdVector.h │ │ └── details.h │ │ ├── SuperLUSupport │ │ └── SuperLUSupport.h │ │ ├── UmfPackSupport │ │ └── UmfPackSupport.h │ │ ├── misc │ │ ├── Image.h │ │ ├── Kernel.h │ │ ├── RealSvd2x2.h │ │ ├── blas.h │ │ ├── lapack.h │ │ ├── lapacke.h │ │ └── lapacke_mangling.h │ │ └── plugins │ │ ├── ArrayCwiseBinaryOps.h │ │ ├── ArrayCwiseUnaryOps.h │ │ ├── BlockMethods.h │ │ ├── CommonCwiseBinaryOps.h │ │ ├── CommonCwiseUnaryOps.h │ │ ├── MatrixCwiseBinaryOps.h │ │ └── MatrixCwiseUnaryOps.h ├── color_propagation.cpp ├── color_propagation.h ├── common.cpp ├── common.h ├── geometry_fit.cpp ├── geometry_fit.h ├── image.cpp ├── image.h ├── landmark.cpp ├── landmark.h ├── math_vec.cpp ├── math_vec.h ├── mesh.cpp ├── mesh.h ├── parameter.h ├── specular_removal_grad.cpp ├── specular_removal_grad.h ├── tex_light_fit.cpp ├── tex_light_fit.h ├── tinyexr.h └── unsupported │ ├── CMakeLists.txt │ ├── Eigen │ ├── AdolcForward │ ├── AlignedVector3 │ ├── ArpackSupport │ ├── AutoDiff │ ├── BVH │ ├── CMakeLists.txt │ ├── CXX11 │ │ ├── CMakeLists.txt │ │ ├── Tensor │ │ ├── TensorSymmetry │ │ ├── ThreadPool │ │ └── src │ │ │ ├── Tensor │ │ │ ├── README.md │ │ │ ├── Tensor.h │ │ │ ├── TensorArgMax.h │ │ │ ├── TensorAssign.h │ │ │ ├── TensorBase.h │ │ │ ├── TensorBroadcasting.h │ │ │ ├── TensorChipping.h │ │ │ ├── TensorConcatenation.h │ │ │ ├── TensorContraction.h │ │ │ ├── TensorContractionBlocking.h │ │ │ ├── TensorContractionCuda.h │ │ │ ├── TensorContractionMapper.h │ │ │ ├── TensorContractionThreadPool.h │ │ │ ├── TensorConversion.h │ │ │ ├── TensorConvolution.h │ │ │ ├── TensorCostModel.h │ │ │ ├── TensorCustomOp.h │ │ │ ├── TensorDevice.h │ │ │ ├── TensorDeviceCuda.h │ │ │ ├── TensorDeviceDefault.h │ │ │ ├── TensorDeviceSycl.h │ │ │ ├── TensorDeviceThreadPool.h │ │ │ ├── TensorDimensionList.h │ │ │ ├── TensorDimensions.h │ │ │ ├── TensorEvalTo.h │ │ │ ├── TensorEvaluator.h │ │ │ ├── TensorExecutor.h │ │ │ ├── TensorExpr.h │ │ │ ├── TensorFFT.h │ │ │ ├── TensorFixedSize.h │ │ │ ├── TensorForcedEval.h │ │ │ ├── TensorForwardDeclarations.h │ │ │ ├── TensorFunctors.h │ │ │ ├── TensorGenerator.h │ │ │ ├── TensorGlobalFunctions.h │ │ │ ├── TensorIO.h │ │ │ ├── TensorImagePatch.h │ │ │ ├── TensorIndexList.h │ │ │ ├── TensorInflation.h │ │ │ ├── TensorInitializer.h │ │ │ ├── TensorIntDiv.h │ │ │ ├── TensorLayoutSwap.h │ │ │ ├── TensorMacros.h │ │ │ ├── TensorMap.h │ │ │ ├── TensorMeta.h │ │ │ ├── TensorMorphing.h │ │ │ ├── TensorPadding.h │ │ │ ├── TensorPatch.h │ │ │ ├── TensorRandom.h │ │ │ ├── TensorReduction.h │ │ │ ├── TensorReductionCuda.h │ │ │ ├── TensorReductionSycl.h │ │ │ ├── TensorRef.h │ │ │ ├── TensorReverse.h │ │ │ ├── TensorScan.h │ │ │ ├── TensorShuffling.h │ │ │ ├── TensorStorage.h │ │ │ ├── TensorStriding.h │ │ │ ├── TensorSycl.h │ │ │ ├── TensorSyclConvertToDeviceExpression.h │ │ │ ├── TensorSyclExprConstructor.h │ │ │ ├── TensorSyclExtractAccessor.h │ │ │ ├── TensorSyclExtractFunctors.h │ │ │ ├── TensorSyclLeafCount.h │ │ │ ├── TensorSyclPlaceHolderExpr.h │ │ │ ├── TensorSyclRun.h │ │ │ ├── TensorSyclTuple.h │ │ │ ├── TensorTraits.h │ │ │ ├── TensorUInt128.h │ │ │ └── TensorVolumePatch.h │ │ │ ├── TensorSymmetry │ │ │ ├── DynamicSymmetry.h │ │ │ ├── StaticSymmetry.h │ │ │ ├── Symmetry.h │ │ │ └── util │ │ │ │ └── TemplateGroupTheory.h │ │ │ ├── ThreadPool │ │ │ ├── EventCount.h │ │ │ ├── NonBlockingThreadPool.h │ │ │ ├── RunQueue.h │ │ │ ├── SimpleThreadPool.h │ │ │ ├── ThreadEnvironment.h │ │ │ ├── ThreadLocal.h │ │ │ ├── ThreadPoolInterface.h │ │ │ └── ThreadYield.h │ │ │ └── util │ │ │ ├── CXX11Meta.h │ │ │ ├── CXX11Workarounds.h │ │ │ ├── EmulateArray.h │ │ │ ├── EmulateCXX11Meta.h │ │ │ └── MaxSizeVector.h │ ├── EulerAngles │ ├── FFT │ ├── IterativeSolvers │ ├── KroneckerProduct │ ├── LevenbergMarquardt │ ├── MPRealSupport │ ├── MatrixFunctions │ ├── MoreVectorization │ ├── NonLinearOptimization │ ├── NumericalDiff │ ├── OpenGLSupport │ ├── Polynomials │ ├── Skyline │ ├── SparseExtra │ ├── SpecialFunctions │ ├── Splines │ └── src │ │ ├── AutoDiff │ │ ├── AutoDiffJacobian.h │ │ ├── AutoDiffScalar.h │ │ └── AutoDiffVector.h │ │ ├── BVH │ │ ├── BVAlgorithms.h │ │ └── KdBVH.h │ │ ├── Eigenvalues │ │ └── ArpackSelfAdjointEigenSolver.h │ │ ├── EulerAngles │ │ ├── CMakeLists.txt │ │ ├── EulerAngles.h │ │ └── EulerSystem.h │ │ ├── FFT │ │ ├── ei_fftw_impl.h │ │ └── ei_kissfft_impl.h │ │ ├── IterativeSolvers │ │ ├── ConstrainedConjGrad.h │ │ ├── DGMRES.h │ │ ├── GMRES.h │ │ ├── IncompleteLU.h │ │ ├── IterationController.h │ │ ├── MINRES.h │ │ └── Scaling.h │ │ ├── KroneckerProduct │ │ └── KroneckerTensorProduct.h │ │ ├── LevenbergMarquardt │ │ ├── CopyrightMINPACK.txt │ │ ├── LMcovar.h │ │ ├── LMonestep.h │ │ ├── LMpar.h │ │ ├── LMqrsolv.h │ │ └── LevenbergMarquardt.h │ │ ├── MatrixFunctions │ │ ├── MatrixExponential.h │ │ ├── MatrixFunction.h │ │ ├── MatrixLogarithm.h │ │ ├── MatrixPower.h │ │ ├── MatrixSquareRoot.h │ │ └── StemFunction.h │ │ ├── MoreVectorization │ │ └── MathFunctions.h │ │ ├── NonLinearOptimization │ │ ├── HybridNonLinearSolver.h │ │ ├── LevenbergMarquardt.h │ │ ├── chkder.h │ │ ├── covar.h │ │ ├── dogleg.h │ │ ├── fdjac1.h │ │ ├── lmpar.h │ │ ├── qrsolv.h │ │ ├── r1mpyq.h │ │ ├── r1updt.h │ │ └── rwupdt.h │ │ ├── NumericalDiff │ │ └── NumericalDiff.h │ │ ├── Polynomials │ │ ├── Companion.h │ │ ├── PolynomialSolver.h │ │ └── PolynomialUtils.h │ │ ├── Skyline │ │ ├── SkylineInplaceLU.h │ │ ├── SkylineMatrix.h │ │ ├── SkylineMatrixBase.h │ │ ├── SkylineProduct.h │ │ ├── SkylineStorage.h │ │ └── SkylineUtil.h │ │ ├── SparseExtra │ │ ├── BlockOfDynamicSparseMatrix.h │ │ ├── BlockSparseMatrix.h │ │ ├── DynamicSparseMatrix.h │ │ ├── MarketIO.h │ │ ├── MatrixMarketIterator.h │ │ └── RandomSetter.h │ │ ├── SpecialFunctions │ │ ├── SpecialFunctionsArrayAPI.h │ │ ├── SpecialFunctionsFunctors.h │ │ ├── SpecialFunctionsHalf.h │ │ ├── SpecialFunctionsImpl.h │ │ ├── SpecialFunctionsPacketMath.h │ │ └── arch │ │ │ └── CUDA │ │ │ └── CudaSpecialFunctions.h │ │ └── Splines │ │ ├── Spline.h │ │ ├── SplineFitting.h │ │ └── SplineFwd.h │ ├── README.txt │ ├── bench │ └── bench_svd.cpp │ ├── doc │ ├── CMakeLists.txt │ ├── Overview.dox │ ├── eigendoxy_layout.xml.in │ ├── examples │ │ ├── BVH_Example.cpp │ │ ├── CMakeLists.txt │ │ ├── EulerAngles.cpp │ │ ├── FFT.cpp │ │ ├── MatrixExponential.cpp │ │ ├── MatrixFunction.cpp │ │ ├── MatrixLogarithm.cpp │ │ ├── MatrixPower.cpp │ │ ├── MatrixPower_optimal.cpp │ │ ├── MatrixSine.cpp │ │ ├── MatrixSinh.cpp │ │ ├── MatrixSquareRoot.cpp │ │ ├── PolynomialSolver1.cpp │ │ └── PolynomialUtils1.cpp │ └── snippets │ │ └── CMakeLists.txt │ └── test │ ├── BVH.cpp │ ├── CMakeLists.txt │ ├── EulerAngles.cpp │ ├── FFT.cpp │ ├── FFTW.cpp │ ├── NonLinearOptimization.cpp │ ├── NumericalDiff.cpp │ ├── alignedvector3.cpp │ ├── autodiff.cpp │ ├── autodiff_scalar.cpp │ ├── cxx11_eventcount.cpp │ ├── cxx11_meta.cpp │ ├── cxx11_non_blocking_thread_pool.cpp │ ├── cxx11_runqueue.cpp │ ├── cxx11_tensor_argmax.cpp │ ├── cxx11_tensor_argmax_cuda.cu │ ├── cxx11_tensor_assign.cpp │ ├── cxx11_tensor_broadcast_sycl.cpp │ ├── cxx11_tensor_broadcasting.cpp │ ├── cxx11_tensor_cast_float16_cuda.cu │ ├── cxx11_tensor_casts.cpp │ ├── cxx11_tensor_chipping.cpp │ ├── cxx11_tensor_comparisons.cpp │ ├── cxx11_tensor_complex_cuda.cu │ ├── cxx11_tensor_complex_cwise_ops_cuda.cu │ ├── cxx11_tensor_concatenation.cpp │ ├── cxx11_tensor_const.cpp │ ├── cxx11_tensor_contract_cuda.cu │ ├── cxx11_tensor_contraction.cpp │ ├── cxx11_tensor_convolution.cpp │ ├── cxx11_tensor_cuda.cu │ ├── cxx11_tensor_custom_index.cpp │ ├── cxx11_tensor_custom_op.cpp │ ├── cxx11_tensor_device.cu │ ├── cxx11_tensor_device_sycl.cpp │ ├── cxx11_tensor_dimension.cpp │ ├── cxx11_tensor_empty.cpp │ ├── cxx11_tensor_expr.cpp │ ├── cxx11_tensor_fft.cpp │ ├── cxx11_tensor_fixed_size.cpp │ ├── cxx11_tensor_forced_eval.cpp │ ├── cxx11_tensor_forced_eval_sycl.cpp │ ├── cxx11_tensor_generator.cpp │ ├── cxx11_tensor_ifft.cpp │ ├── cxx11_tensor_image_patch.cpp │ ├── cxx11_tensor_index_list.cpp │ ├── cxx11_tensor_inflation.cpp │ ├── cxx11_tensor_intdiv.cpp │ ├── cxx11_tensor_io.cpp │ ├── cxx11_tensor_layout_swap.cpp │ ├── cxx11_tensor_lvalue.cpp │ ├── cxx11_tensor_map.cpp │ ├── cxx11_tensor_math.cpp │ ├── cxx11_tensor_mixed_indices.cpp │ ├── cxx11_tensor_morphing.cpp │ ├── cxx11_tensor_notification.cpp │ ├── cxx11_tensor_of_complex.cpp │ ├── cxx11_tensor_of_const_values.cpp │ ├── cxx11_tensor_of_float16_cuda.cu │ ├── cxx11_tensor_of_strings.cpp │ ├── cxx11_tensor_padding.cpp │ ├── cxx11_tensor_patch.cpp │ ├── cxx11_tensor_random.cpp │ ├── cxx11_tensor_random_cuda.cu │ ├── cxx11_tensor_reduction.cpp │ ├── cxx11_tensor_reduction_cuda.cu │ ├── cxx11_tensor_reduction_sycl.cpp │ ├── cxx11_tensor_ref.cpp │ ├── cxx11_tensor_reverse.cpp │ ├── cxx11_tensor_roundings.cpp │ ├── cxx11_tensor_scan.cpp │ ├── cxx11_tensor_scan_cuda.cu │ ├── cxx11_tensor_shuffling.cpp │ ├── cxx11_tensor_simple.cpp │ ├── cxx11_tensor_striding.cpp │ ├── cxx11_tensor_sugar.cpp │ ├── cxx11_tensor_sycl.cpp │ ├── cxx11_tensor_symmetry.cpp │ ├── cxx11_tensor_thread_pool.cpp │ ├── cxx11_tensor_uint128.cpp │ ├── cxx11_tensor_volume_patch.cpp │ ├── dgmres.cpp │ ├── forward_adolc.cpp │ ├── gmres.cpp │ ├── kronecker_product.cpp │ ├── levenberg_marquardt.cpp │ ├── matrix_exponential.cpp │ ├── matrix_function.cpp │ ├── matrix_functions.h │ ├── matrix_power.cpp │ ├── matrix_square_root.cpp │ ├── minres.cpp │ ├── mpreal │ └── mpreal.h │ ├── mpreal_support.cpp │ ├── openglsupport.cpp │ ├── polynomialsolver.cpp │ ├── polynomialutils.cpp │ ├── sparse_extra.cpp │ ├── special_functions.cpp │ └── splines.cpp ├── landmark ├── CCNF_patch_expert.cpp ├── CCNF_patch_expert.h ├── LandmarkCoreIncludes.h ├── LandmarkDetectionValidator.cpp ├── LandmarkDetectionValidator.h ├── LandmarkDetectorFunc.cpp ├── LandmarkDetectorFunc.h ├── LandmarkDetectorModel.cpp ├── LandmarkDetectorModel.h ├── LandmarkDetectorParameters.cpp ├── LandmarkDetectorParameters.h ├── LandmarkDetectorUtils.cpp ├── LandmarkDetectorUtils.h ├── PAW.cpp ├── PAW.h ├── PDM.cpp ├── PDM.h ├── Patch_experts.cpp ├── Patch_experts.h ├── SVR_patch_expert.cpp ├── SVR_patch_expert.h ├── dlib │ ├── CMakeLists.txt │ ├── LICENSE.txt │ ├── algs.h │ ├── all │ │ └── source.cpp │ ├── any.h │ ├── any │ │ ├── any.h │ │ ├── any_abstract.h │ │ ├── any_decision_function.h │ │ ├── any_decision_function_abstract.h │ │ ├── any_function.h │ │ ├── any_function_abstract.h │ │ ├── any_function_impl.h │ │ ├── any_function_impl2.h │ │ ├── any_trainer.h │ │ └── any_trainer_abstract.h │ ├── appveyor │ │ ├── dtest.yml │ │ ├── dtest_vc2017.yml │ │ ├── examples.yml │ │ └── python.yml │ ├── array.h │ ├── array │ │ ├── array_kernel.h │ │ ├── array_kernel_abstract.h │ │ ├── array_tools.h │ │ └── array_tools_abstract.h │ ├── array2d.h │ ├── array2d │ │ ├── array2d_generic_image.h │ │ ├── array2d_kernel.h │ │ ├── array2d_kernel_abstract.h │ │ └── serialize_pixel_overloads.h │ ├── assert.h │ ├── base64.h │ ├── base64 │ │ ├── base64_kernel_1.cpp │ │ ├── base64_kernel_1.h │ │ └── base64_kernel_abstract.h │ ├── bayes_utils.h │ ├── bayes_utils │ │ ├── bayes_utils.h │ │ └── bayes_utils_abstract.h │ ├── bigint.h │ ├── bigint │ │ ├── bigint_kernel_1.cpp │ │ ├── bigint_kernel_1.h │ │ ├── bigint_kernel_2.cpp │ │ ├── bigint_kernel_2.h │ │ ├── bigint_kernel_abstract.h │ │ └── bigint_kernel_c.h │ ├── binary_search_tree.h │ ├── binary_search_tree │ │ ├── binary_search_tree_kernel_1.h │ │ ├── binary_search_tree_kernel_2.h │ │ ├── binary_search_tree_kernel_abstract.h │ │ └── binary_search_tree_kernel_c.h │ ├── bit_stream.h │ ├── bit_stream │ │ ├── bit_stream_kernel_1.cpp │ │ ├── bit_stream_kernel_1.h │ │ ├── bit_stream_kernel_abstract.h │ │ ├── bit_stream_kernel_c.h │ │ ├── bit_stream_multi_1.h │ │ ├── bit_stream_multi_abstract.h │ │ └── bit_stream_multi_c.h │ ├── bits │ │ └── c++config.h │ ├── bound_function_pointer.h │ ├── bound_function_pointer │ │ ├── bound_function_pointer_kernel_1.h │ │ └── bound_function_pointer_kernel_abstract.h │ ├── bridge.h │ ├── bridge │ │ ├── bridge.h │ │ └── bridge_abstract.h │ ├── bsp.h │ ├── bsp │ │ ├── bsp.cpp │ │ ├── bsp.h │ │ └── bsp_abstract.h │ ├── byte_orderer.h │ ├── byte_orderer │ │ ├── byte_orderer_kernel_1.h │ │ └── byte_orderer_kernel_abstract.h │ ├── cassert │ ├── clustering.h │ ├── clustering │ │ ├── bottom_up_cluster.h │ │ ├── bottom_up_cluster_abstract.h │ │ ├── chinese_whispers.h │ │ ├── chinese_whispers_abstract.h │ │ ├── modularity_clustering.h │ │ ├── modularity_clustering_abstract.h │ │ ├── spectral_cluster.h │ │ └── spectral_cluster_abstract.h │ ├── cmake │ ├── cmake_utils │ │ ├── add_global_compiler_switch.cmake │ │ ├── check_if_avx_instructions_executable_on_host.cmake │ │ ├── check_if_neon_available.cmake │ │ ├── check_if_sse4_instructions_executable_on_host.cmake │ │ ├── dlib.pc.in │ │ ├── dlibConfig.cmake.in │ │ ├── find_blas.cmake │ │ ├── release_build_by_default │ │ ├── set_compiler_specific_options.cmake │ │ ├── tell_visual_studio_to_use_static_runtime.cmake │ │ ├── test_for_avx │ │ │ ├── CMakeLists.txt │ │ │ ├── avx_test.cpp │ │ │ └── this_file_doesnt_compile.cpp │ │ ├── test_for_cpp11 │ │ │ ├── CMakeLists.txt │ │ │ └── cpp11_test.cpp │ │ ├── test_for_cuda │ │ │ ├── CMakeLists.txt │ │ │ └── cuda_test.cu │ │ ├── test_for_cudnn │ │ │ ├── CMakeLists.txt │ │ │ └── find_cudnn.txt │ │ ├── test_for_neon │ │ │ ├── CMakeLists.txt │ │ │ └── neon_test.cpp │ │ ├── test_for_sse4 │ │ │ ├── CMakeLists.txt │ │ │ ├── sse4_test.cpp │ │ │ └── this_file_doesnt_compile.cpp │ │ └── use_cpp_11.cmake │ ├── cmd_line_parser.h │ ├── cmd_line_parser │ │ ├── cmd_line_parser_check_1.h │ │ ├── cmd_line_parser_check_c.h │ │ ├── cmd_line_parser_kernel_1.h │ │ ├── cmd_line_parser_kernel_abstract.h │ │ ├── cmd_line_parser_kernel_c.h │ │ ├── cmd_line_parser_print_1.h │ │ ├── get_option.h │ │ └── get_option_abstract.h │ ├── compress_stream.h │ ├── compress_stream │ │ ├── compress_stream_kernel_1.h │ │ ├── compress_stream_kernel_2.h │ │ ├── compress_stream_kernel_3.h │ │ └── compress_stream_kernel_abstract.h │ ├── conditioning_class.h │ ├── conditioning_class │ │ ├── conditioning_class_kernel_1.h │ │ ├── conditioning_class_kernel_2.h │ │ ├── conditioning_class_kernel_3.h │ │ ├── conditioning_class_kernel_4.h │ │ ├── conditioning_class_kernel_abstract.h │ │ └── conditioning_class_kernel_c.h │ ├── config.h │ ├── config.h.in │ ├── config_reader.h │ ├── config_reader │ │ ├── config_reader_kernel_1.h │ │ ├── config_reader_kernel_abstract.h │ │ ├── config_reader_thread_safe_1.h │ │ └── config_reader_thread_safe_abstract.h │ ├── console_progress_indicator.h │ ├── control.h │ ├── control │ │ ├── approximate_linear_models.h │ │ ├── approximate_linear_models_abstract.h │ │ ├── lspi.h │ │ ├── lspi_abstract.h │ │ ├── mpc.h │ │ └── mpc_abstract.h │ ├── cpp_pretty_printer.h │ ├── cpp_pretty_printer │ │ ├── cpp_pretty_printer_kernel_1.h │ │ ├── cpp_pretty_printer_kernel_2.h │ │ └── cpp_pretty_printer_kernel_abstract.h │ ├── cpp_tokenizer.h │ ├── cpp_tokenizer │ │ ├── cpp_tokenizer_kernel_1.h │ │ ├── cpp_tokenizer_kernel_abstract.h │ │ └── cpp_tokenizer_kernel_c.h │ ├── crc32.h │ ├── crc32 │ │ ├── crc32_kernel_1.h │ │ └── crc32_kernel_abstract.h │ ├── cstring │ ├── cuda │ │ ├── cpu_dlib.cpp │ │ ├── cpu_dlib.h │ │ ├── cublas_dlibapi.cpp │ │ ├── cublas_dlibapi.h │ │ ├── cuda_data_ptr.cpp │ │ ├── cuda_data_ptr.h │ │ ├── cuda_dlib.cu │ │ ├── cuda_dlib.h │ │ ├── cuda_errors.h │ │ ├── cuda_utils.h │ │ ├── cudnn_dlibapi.cpp │ │ ├── cudnn_dlibapi.h │ │ ├── curand_dlibapi.cpp │ │ ├── curand_dlibapi.h │ │ ├── cusolver_dlibapi.cu │ │ ├── cusolver_dlibapi.h │ │ ├── gpu_data.cpp │ │ ├── gpu_data.h │ │ ├── gpu_data_abstract.h │ │ ├── tensor.h │ │ ├── tensor_abstract.h │ │ ├── tensor_tools.cpp │ │ └── tensor_tools.h │ ├── data_io.h │ ├── data_io │ │ ├── image_dataset_metadata.cpp │ │ ├── image_dataset_metadata.h │ │ ├── libsvm_io.h │ │ ├── libsvm_io_abstract.h │ │ ├── load_image_dataset.h │ │ ├── load_image_dataset_abstract.h │ │ ├── mnist.cpp │ │ ├── mnist.h │ │ └── mnist_abstract.h │ ├── dir_nav.h │ ├── dir_nav │ │ ├── dir_nav_extensions.cpp │ │ ├── dir_nav_extensions.h │ │ ├── dir_nav_extensions_abstract.h │ │ ├── dir_nav_kernel_1.cpp │ │ ├── dir_nav_kernel_1.h │ │ ├── dir_nav_kernel_2.cpp │ │ ├── dir_nav_kernel_2.h │ │ ├── dir_nav_kernel_abstract.h │ │ ├── posix.h │ │ └── windows.h │ ├── directed_graph.h │ ├── directed_graph │ │ ├── directed_graph_kernel_1.h │ │ └── directed_graph_kernel_abstract.h │ ├── disjoint_subsets.h │ ├── disjoint_subsets │ │ ├── disjoint_subsets.h │ │ ├── disjoint_subsets_abstract.h │ │ ├── disjoint_subsets_sized.h │ │ └── disjoint_subsets_sized_abstract.h │ ├── dlib_basic_cpp_build_tutorial.txt │ ├── dlib_include_path_tutorial.txt │ ├── dnn.h │ ├── dnn │ │ ├── core.h │ │ ├── core_abstract.h │ │ ├── input.h │ │ ├── input_abstract.h │ │ ├── layers.h │ │ ├── layers_abstract.h │ │ ├── loss.h │ │ ├── loss_abstract.h │ │ ├── solvers.h │ │ ├── solvers_abstract.h │ │ ├── trainer.h │ │ ├── trainer_abstract.h │ │ ├── utilities.h │ │ ├── utilities_abstract.h │ │ └── validation.h │ ├── enable_if.h │ ├── entropy_decoder.h │ ├── entropy_decoder │ │ ├── entropy_decoder_kernel_1.cpp │ │ ├── entropy_decoder_kernel_1.h │ │ ├── entropy_decoder_kernel_2.cpp │ │ ├── entropy_decoder_kernel_2.h │ │ ├── entropy_decoder_kernel_abstract.h │ │ └── entropy_decoder_kernel_c.h │ ├── entropy_decoder_model.h │ ├── entropy_decoder_model │ │ ├── entropy_decoder_model_kernel_1.h │ │ ├── entropy_decoder_model_kernel_2.h │ │ ├── entropy_decoder_model_kernel_3.h │ │ ├── entropy_decoder_model_kernel_4.h │ │ ├── entropy_decoder_model_kernel_5.h │ │ ├── entropy_decoder_model_kernel_6.h │ │ └── entropy_decoder_model_kernel_abstract.h │ ├── entropy_encoder.h │ ├── entropy_encoder │ │ ├── entropy_encoder_kernel_1.cpp │ │ ├── entropy_encoder_kernel_1.h │ │ ├── entropy_encoder_kernel_2.cpp │ │ ├── entropy_encoder_kernel_2.h │ │ ├── entropy_encoder_kernel_abstract.h │ │ └── entropy_encoder_kernel_c.h │ ├── entropy_encoder_model.h │ ├── entropy_encoder_model │ │ ├── entropy_encoder_model_kernel_1.h │ │ ├── entropy_encoder_model_kernel_2.h │ │ ├── entropy_encoder_model_kernel_3.h │ │ ├── entropy_encoder_model_kernel_4.h │ │ ├── entropy_encoder_model_kernel_5.h │ │ ├── entropy_encoder_model_kernel_6.h │ │ ├── entropy_encoder_model_kernel_abstract.h │ │ └── entropy_encoder_model_kernel_c.h │ ├── error.h │ ├── external │ │ ├── cblas │ │ │ ├── CMakeLists.txt │ │ │ ├── README │ │ │ ├── cblas.h │ │ │ ├── cblas_caxpy.c │ │ │ ├── cblas_ccopy.c │ │ │ ├── cblas_cdotc_sub.c │ │ │ ├── cblas_cdotu_sub.c │ │ │ ├── cblas_cgbmv.c │ │ │ ├── cblas_cgemm.c │ │ │ ├── cblas_cgemv.c │ │ │ ├── cblas_cgerc.c │ │ │ ├── cblas_cgeru.c │ │ │ ├── cblas_chbmv.c │ │ │ ├── cblas_chemm.c │ │ │ ├── cblas_chemv.c │ │ │ ├── cblas_cher.c │ │ │ ├── cblas_cher2.c │ │ │ ├── cblas_cher2k.c │ │ │ ├── cblas_cherk.c │ │ │ ├── cblas_chpmv.c │ │ │ ├── cblas_chpr.c │ │ │ ├── cblas_chpr2.c │ │ │ ├── cblas_cscal.c │ │ │ ├── cblas_csscal.c │ │ │ ├── cblas_cswap.c │ │ │ ├── cblas_csymm.c │ │ │ ├── cblas_csyr2k.c │ │ │ ├── cblas_csyrk.c │ │ │ ├── cblas_ctbmv.c │ │ │ ├── cblas_ctbsv.c │ │ │ ├── cblas_ctpmv.c │ │ │ ├── cblas_ctpsv.c │ │ │ ├── cblas_ctrmm.c │ │ │ ├── cblas_ctrmv.c │ │ │ ├── cblas_ctrsm.c │ │ │ ├── cblas_ctrsv.c │ │ │ ├── cblas_dasum.c │ │ │ ├── cblas_daxpy.c │ │ │ ├── cblas_dcopy.c │ │ │ ├── cblas_ddot.c │ │ │ ├── cblas_dgbmv.c │ │ │ ├── cblas_dgemm.c │ │ │ ├── cblas_dgemv.c │ │ │ ├── cblas_dger.c │ │ │ ├── cblas_dnrm2.c │ │ │ ├── cblas_drot.c │ │ │ ├── cblas_drotg.c │ │ │ ├── cblas_drotm.c │ │ │ ├── cblas_drotmg.c │ │ │ ├── cblas_dsbmv.c │ │ │ ├── cblas_dscal.c │ │ │ ├── cblas_dsdot.c │ │ │ ├── cblas_dspmv.c │ │ │ ├── cblas_dspr.c │ │ │ ├── cblas_dspr2.c │ │ │ ├── cblas_dswap.c │ │ │ ├── cblas_dsymm.c │ │ │ ├── cblas_dsymv.c │ │ │ ├── cblas_dsyr.c │ │ │ ├── cblas_dsyr2.c │ │ │ ├── cblas_dsyr2k.c │ │ │ ├── cblas_dsyrk.c │ │ │ ├── cblas_dtbmv.c │ │ │ ├── cblas_dtbsv.c │ │ │ ├── cblas_dtpmv.c │ │ │ ├── cblas_dtpsv.c │ │ │ ├── cblas_dtrmm.c │ │ │ ├── cblas_dtrmv.c │ │ │ ├── cblas_dtrsm.c │ │ │ ├── cblas_dtrsv.c │ │ │ ├── cblas_dzasum.c │ │ │ ├── cblas_dznrm2.c │ │ │ ├── cblas_f77.h │ │ │ ├── cblas_icamax.c │ │ │ ├── cblas_idamax.c │ │ │ ├── cblas_isamax.c │ │ │ ├── cblas_izamax.c │ │ │ ├── cblas_sasum.c │ │ │ ├── cblas_saxpy.c │ │ │ ├── cblas_scasum.c │ │ │ ├── cblas_scnrm2.c │ │ │ ├── cblas_scopy.c │ │ │ ├── cblas_sdot.c │ │ │ ├── cblas_sdsdot.c │ │ │ ├── cblas_sgbmv.c │ │ │ ├── cblas_sgemm.c │ │ │ ├── cblas_sgemv.c │ │ │ ├── cblas_sger.c │ │ │ ├── cblas_snrm2.c │ │ │ ├── cblas_srot.c │ │ │ ├── cblas_srotg.c │ │ │ ├── cblas_srotm.c │ │ │ ├── cblas_srotmg.c │ │ │ ├── cblas_ssbmv.c │ │ │ ├── cblas_sscal.c │ │ │ ├── cblas_sspmv.c │ │ │ ├── cblas_sspr.c │ │ │ ├── cblas_sspr2.c │ │ │ ├── cblas_sswap.c │ │ │ ├── cblas_ssymm.c │ │ │ ├── cblas_ssymv.c │ │ │ ├── cblas_ssyr.c │ │ │ ├── cblas_ssyr2.c │ │ │ ├── cblas_ssyr2k.c │ │ │ ├── cblas_ssyrk.c │ │ │ ├── cblas_stbmv.c │ │ │ ├── cblas_stbsv.c │ │ │ ├── cblas_stpmv.c │ │ │ ├── cblas_stpsv.c │ │ │ ├── cblas_strmm.c │ │ │ ├── cblas_strmv.c │ │ │ ├── cblas_strsm.c │ │ │ ├── cblas_strsv.c │ │ │ ├── cblas_xerbla.c │ │ │ ├── cblas_zaxpy.c │ │ │ ├── cblas_zcopy.c │ │ │ ├── cblas_zdotc_sub.c │ │ │ ├── cblas_zdotu_sub.c │ │ │ ├── cblas_zdscal.c │ │ │ ├── cblas_zgbmv.c │ │ │ ├── cblas_zgemm.c │ │ │ ├── cblas_zgemv.c │ │ │ ├── cblas_zgerc.c │ │ │ ├── cblas_zgeru.c │ │ │ ├── cblas_zhbmv.c │ │ │ ├── cblas_zhemm.c │ │ │ ├── cblas_zhemv.c │ │ │ ├── cblas_zher.c │ │ │ ├── cblas_zher2.c │ │ │ ├── cblas_zher2k.c │ │ │ ├── cblas_zherk.c │ │ │ ├── cblas_zhpmv.c │ │ │ ├── cblas_zhpr.c │ │ │ ├── cblas_zhpr2.c │ │ │ ├── cblas_zscal.c │ │ │ ├── cblas_zswap.c │ │ │ ├── cblas_zsymm.c │ │ │ ├── cblas_zsyr2k.c │ │ │ ├── cblas_zsyrk.c │ │ │ ├── cblas_ztbmv.c │ │ │ ├── cblas_ztbsv.c │ │ │ ├── cblas_ztpmv.c │ │ │ ├── cblas_ztpsv.c │ │ │ ├── cblas_ztrmm.c │ │ │ ├── cblas_ztrmv.c │ │ │ ├── cblas_ztrsm.c │ │ │ ├── cblas_ztrsv.c │ │ │ ├── cdotcsub.f │ │ │ ├── cdotusub.f │ │ │ ├── dasumsub.f │ │ │ ├── ddotsub.f │ │ │ ├── dnrm2sub.f │ │ │ ├── dsdotsub.f │ │ │ ├── dzasumsub.f │ │ │ ├── dznrm2sub.f │ │ │ ├── icamaxsub.f │ │ │ ├── idamaxsub.f │ │ │ ├── isamaxsub.f │ │ │ ├── izamaxsub.f │ │ │ ├── sasumsub.f │ │ │ ├── scasumsub.f │ │ │ ├── scnrm2sub.f │ │ │ ├── sdotsub.f │ │ │ ├── sdsdotsub.f │ │ │ ├── snrm2sub.f │ │ │ ├── zdotcsub.f │ │ │ └── zdotusub.f │ │ ├── libjpeg │ │ │ ├── README │ │ │ ├── jcapimin.cpp │ │ │ ├── jcapistd.cpp │ │ │ ├── jccoefct.cpp │ │ │ ├── jccolor.cpp │ │ │ ├── jcdctmgr.cpp │ │ │ ├── jchuff.cpp │ │ │ ├── jchuff.h │ │ │ ├── jcinit.cpp │ │ │ ├── jcmainct.cpp │ │ │ ├── jcmarker.cpp │ │ │ ├── jcmaster.cpp │ │ │ ├── jcomapi.cpp │ │ │ ├── jconfig.h │ │ │ ├── jcparam.cpp │ │ │ ├── jcphuff.cpp │ │ │ ├── jcprepct.cpp │ │ │ ├── jcsample.cpp │ │ │ ├── jdapimin.cpp │ │ │ ├── jdapistd.cpp │ │ │ ├── jdatadst.cpp │ │ │ ├── jdatasrc.cpp │ │ │ ├── jdcoefct.cpp │ │ │ ├── jdcolor.cpp │ │ │ ├── jdct.h │ │ │ ├── jddctmgr.cpp │ │ │ ├── jdhuff.cpp │ │ │ ├── jdhuff.h │ │ │ ├── jdinput.cpp │ │ │ ├── jdmainct.cpp │ │ │ ├── jdmarker.cpp │ │ │ ├── jdmaster.cpp │ │ │ ├── jdmerge.cpp │ │ │ ├── jdphuff.cpp │ │ │ ├── jdpostct.cpp │ │ │ ├── jdsample.cpp │ │ │ ├── jerror.cpp │ │ │ ├── jerror.h │ │ │ ├── jfdctflt.cpp │ │ │ ├── jfdctfst.cpp │ │ │ ├── jfdctint.cpp │ │ │ ├── jidctflt.cpp │ │ │ ├── jidctfst.cpp │ │ │ ├── jidctint.cpp │ │ │ ├── jidctred.cpp │ │ │ ├── jinclude.h │ │ │ ├── jmemmgr.cpp │ │ │ ├── jmemnobs.cpp │ │ │ ├── jmemsys.h │ │ │ ├── jmorecfg.h │ │ │ ├── jpegint.h │ │ │ ├── jpeglib.h │ │ │ ├── jquant1.cpp │ │ │ ├── jquant2.cpp │ │ │ ├── jutils.cpp │ │ │ └── jversion.h │ │ ├── libpng │ │ │ ├── LICENSE │ │ │ ├── README │ │ │ ├── arm │ │ │ │ ├── arm_init.c │ │ │ │ ├── filter_neon.S │ │ │ │ └── filter_neon_intrinsics.c │ │ │ ├── png.c │ │ │ ├── png.h │ │ │ ├── pngconf.h │ │ │ ├── pngdebug.h │ │ │ ├── pngerror.c │ │ │ ├── pngget.c │ │ │ ├── pnginfo.h │ │ │ ├── pnglibconf.h │ │ │ ├── pngmem.c │ │ │ ├── pngpread.c │ │ │ ├── pngpriv.h │ │ │ ├── pngread.c │ │ │ ├── pngrio.c │ │ │ ├── pngrtran.c │ │ │ ├── pngrutil.c │ │ │ ├── pngset.c │ │ │ ├── pngstruct.h │ │ │ ├── pngtrans.c │ │ │ ├── pngwio.c │ │ │ ├── pngwrite.c │ │ │ ├── pngwtran.c │ │ │ └── pngwutil.c │ │ ├── pybind11 │ │ │ ├── CMakeLists.txt │ │ │ ├── CONTRIBUTING.md │ │ │ ├── LICENSE │ │ │ ├── README.md │ │ │ ├── include │ │ │ │ └── pybind11 │ │ │ │ │ ├── attr.h │ │ │ │ │ ├── buffer_info.h │ │ │ │ │ ├── cast.h │ │ │ │ │ ├── chrono.h │ │ │ │ │ ├── common.h │ │ │ │ │ ├── complex.h │ │ │ │ │ ├── detail │ │ │ │ │ ├── class.h │ │ │ │ │ ├── common.h │ │ │ │ │ ├── descr.h │ │ │ │ │ ├── init.h │ │ │ │ │ ├── internals.h │ │ │ │ │ └── typeid.h │ │ │ │ │ ├── eigen.h │ │ │ │ │ ├── embed.h │ │ │ │ │ ├── eval.h │ │ │ │ │ ├── functional.h │ │ │ │ │ ├── iostream.h │ │ │ │ │ ├── numpy.h │ │ │ │ │ ├── operators.h │ │ │ │ │ ├── options.h │ │ │ │ │ ├── pybind11.h │ │ │ │ │ ├── pytypes.h │ │ │ │ │ ├── stl.h │ │ │ │ │ └── stl_bind.h │ │ │ └── tools │ │ │ │ ├── FindCatch.cmake │ │ │ │ ├── FindEigen3.cmake │ │ │ │ ├── FindPythonLibsNew.cmake │ │ │ │ ├── check-style.sh │ │ │ │ ├── libsize.py │ │ │ │ ├── mkdoc.py │ │ │ │ ├── pybind11Config.cmake.in │ │ │ │ └── pybind11Tools.cmake │ │ └── zlib │ │ │ ├── README │ │ │ ├── adler32.c │ │ │ ├── compress.c │ │ │ ├── crc32.c │ │ │ ├── crc32.h │ │ │ ├── deflate.c │ │ │ ├── deflate.h │ │ │ ├── gzclose.c │ │ │ ├── gzguts.h │ │ │ ├── gzlib.c │ │ │ ├── gzread.c │ │ │ ├── gzwrite.c │ │ │ ├── infback.c │ │ │ ├── inffast.c │ │ │ ├── inffast.h │ │ │ ├── inffixed.h │ │ │ ├── inflate.c │ │ │ ├── inflate.h │ │ │ ├── inftrees.c │ │ │ ├── inftrees.h │ │ │ ├── trees.c │ │ │ ├── trees.h │ │ │ ├── uncompr.c │ │ │ ├── zconf.h │ │ │ ├── zlib.h │ │ │ ├── zutil.c │ │ │ └── zutil.h │ ├── filtering.h │ ├── filtering │ │ ├── kalman_filter.cpp │ │ ├── kalman_filter.h │ │ ├── kalman_filter_abstract.h │ │ ├── rls_filter.h │ │ └── rls_filter_abstract.h │ ├── float_details.h │ ├── fstream │ ├── general_hash │ │ ├── count_bits.h │ │ ├── count_bits_abstract.h │ │ ├── general_hash.h │ │ ├── hash.h │ │ ├── hash_abstract.h │ │ ├── murmur_hash3.h │ │ ├── murmur_hash3_abstract.h │ │ ├── random_hashing.h │ │ └── random_hashing_abstract.h │ ├── geometry.h │ ├── geometry │ │ ├── border_enumerator.h │ │ ├── border_enumerator_abstract.h │ │ ├── drectangle.h │ │ ├── drectangle_abstract.h │ │ ├── line.h │ │ ├── line_abstract.h │ │ ├── point_transforms.h │ │ ├── point_transforms_abstract.h │ │ ├── rectangle.h │ │ ├── rectangle_abstract.h │ │ ├── vector.h │ │ └── vector_abstract.h │ ├── global_optimization.h │ ├── global_optimization │ │ ├── find_max_global.h │ │ ├── find_max_global_abstract.h │ │ ├── global_function_search.cpp │ │ ├── global_function_search.h │ │ ├── global_function_search_abstract.h │ │ ├── upper_bound_function.h │ │ └── upper_bound_function_abstract.h │ ├── graph.h │ ├── graph │ │ ├── graph_kernel_1.h │ │ └── graph_kernel_abstract.h │ ├── graph_cuts.h │ ├── graph_cuts │ │ ├── find_max_factor_graph_potts.h │ │ ├── find_max_factor_graph_potts_abstract.h │ │ ├── general_flow_graph.h │ │ ├── general_potts_problem.h │ │ ├── graph_labeler.h │ │ ├── graph_labeler_abstract.h │ │ ├── min_cut.h │ │ └── min_cut_abstract.h │ ├── graph_utils.h │ ├── graph_utils │ │ ├── edge_list_graphs.h │ │ ├── edge_list_graphs_abstract.h │ │ ├── find_k_nearest_neighbors_lsh.h │ │ ├── find_k_nearest_neighbors_lsh_abstract.h │ │ ├── function_objects.h │ │ ├── function_objects_abstract.h │ │ ├── graph_utils.h │ │ ├── graph_utils_abstract.h │ │ ├── ordered_sample_pair.h │ │ ├── ordered_sample_pair_abstract.h │ │ ├── sample_pair.h │ │ └── sample_pair_abstract.h │ ├── graph_utils_threaded.h │ ├── gui_core.h │ ├── gui_core │ │ ├── gui_core_kernel_1.cpp │ │ ├── gui_core_kernel_1.h │ │ ├── gui_core_kernel_2.cpp │ │ ├── gui_core_kernel_2.h │ │ ├── gui_core_kernel_abstract.h │ │ ├── windows.h │ │ └── xlib.h │ ├── gui_widgets.h │ ├── gui_widgets │ │ ├── base_widgets.cpp │ │ ├── base_widgets.h │ │ ├── base_widgets_abstract.h │ │ ├── canvas_drawing.cpp │ │ ├── canvas_drawing.h │ │ ├── canvas_drawing_abstract.h │ │ ├── drawable.cpp │ │ ├── drawable.h │ │ ├── drawable_abstract.h │ │ ├── fonts.cpp │ │ ├── fonts.h │ │ ├── fonts_abstract.h │ │ ├── nativefont.h │ │ ├── style.cpp │ │ ├── style.h │ │ ├── style_abstract.h │ │ ├── widgets.cpp │ │ ├── widgets.h │ │ └── widgets_abstract.h │ ├── hash.h │ ├── hash_map.h │ ├── hash_map │ │ ├── hash_map_kernel_1.h │ │ ├── hash_map_kernel_abstract.h │ │ └── hash_map_kernel_c.h │ ├── hash_set.h │ ├── hash_set │ │ ├── hash_set_kernel_1.h │ │ ├── hash_set_kernel_abstract.h │ │ └── hash_set_kernel_c.h │ ├── hash_table.h │ ├── hash_table │ │ ├── hash_table_kernel_1.h │ │ ├── hash_table_kernel_2.h │ │ ├── hash_table_kernel_abstract.h │ │ └── hash_table_kernel_c.h │ ├── http_client │ │ ├── http_client.cpp │ │ ├── http_client.h │ │ └── http_client_abstract.h │ ├── image_io.h │ ├── image_keypoint.h │ ├── image_keypoint │ │ ├── binned_vector_feature_image.h │ │ ├── binned_vector_feature_image_abstract.h │ │ ├── build_separable_poly_filters.h │ │ ├── draw_surf_points.h │ │ ├── draw_surf_points_abstract.h │ │ ├── fine_hog_image.h │ │ ├── fine_hog_image_abstract.h │ │ ├── hashed_feature_image.h │ │ ├── hashed_feature_image_abstract.h │ │ ├── hessian_pyramid.h │ │ ├── hessian_pyramid_abstract.h │ │ ├── hog.h │ │ ├── hog_abstract.h │ │ ├── nearest_neighbor_feature_image.h │ │ ├── nearest_neighbor_feature_image_abstract.h │ │ ├── poly_image.h │ │ ├── poly_image_abstract.h │ │ ├── surf.h │ │ └── surf_abstract.h │ ├── image_loader │ │ ├── image_loader.h │ │ ├── image_loader_abstract.h │ │ ├── jpeg_loader.cpp │ │ ├── jpeg_loader.h │ │ ├── jpeg_loader_abstract.h │ │ ├── load_image.h │ │ ├── load_image_abstract.h │ │ ├── png_loader.cpp │ │ ├── png_loader.h │ │ └── png_loader_abstract.h │ ├── image_processing.h │ ├── image_processing │ │ ├── box_overlap_testing.h │ │ ├── box_overlap_testing_abstract.h │ │ ├── correlation_tracker.h │ │ ├── correlation_tracker_abstract.h │ │ ├── detection_template_tools.h │ │ ├── detection_template_tools_abstract.h │ │ ├── frontal_face_detector.h │ │ ├── frontal_face_detector_abstract.h │ │ ├── full_object_detection.h │ │ ├── full_object_detection_abstract.h │ │ ├── generic_image.h │ │ ├── object_detector.h │ │ ├── object_detector_abstract.h │ │ ├── remove_unobtainable_rectangles.h │ │ ├── remove_unobtainable_rectangles_abstract.h │ │ ├── render_face_detections.h │ │ ├── render_face_detections_abstract.h │ │ ├── scan_fhog_pyramid.h │ │ ├── scan_fhog_pyramid_abstract.h │ │ ├── scan_image.h │ │ ├── scan_image_abstract.h │ │ ├── scan_image_boxes.h │ │ ├── scan_image_boxes_abstract.h │ │ ├── scan_image_custom.h │ │ ├── scan_image_custom_abstract.h │ │ ├── scan_image_pyramid.h │ │ ├── scan_image_pyramid_abstract.h │ │ ├── scan_image_pyramid_tools.h │ │ ├── scan_image_pyramid_tools_abstract.h │ │ ├── setup_hashed_features.h │ │ ├── setup_hashed_features_abstract.h │ │ ├── shape_predictor.h │ │ ├── shape_predictor_abstract.h │ │ ├── shape_predictor_trainer.h │ │ └── shape_predictor_trainer_abstract.h │ ├── image_saver │ │ ├── dng_shared.h │ │ ├── image_saver.h │ │ ├── image_saver_abstract.h │ │ ├── save_jpeg.cpp │ │ ├── save_jpeg.h │ │ ├── save_jpeg_abstract.h │ │ ├── save_png.cpp │ │ ├── save_png.h │ │ └── save_png_abstract.h │ ├── image_transforms.h │ ├── image_transforms │ │ ├── assign_image.h │ │ ├── assign_image_abstract.h │ │ ├── colormaps.h │ │ ├── colormaps_abstract.h │ │ ├── draw.h │ │ ├── draw_abstract.h │ │ ├── edge_detector.h │ │ ├── edge_detector_abstract.h │ │ ├── equalize_histogram.h │ │ ├── equalize_histogram_abstract.h │ │ ├── fhog.h │ │ ├── fhog_abstract.h │ │ ├── hough_transform.h │ │ ├── hough_transform_abstract.h │ │ ├── image_pyramid.h │ │ ├── image_pyramid_abstract.h │ │ ├── integral_image.h │ │ ├── integral_image_abstract.h │ │ ├── interpolation.h │ │ ├── interpolation_abstract.h │ │ ├── label_connected_blobs.h │ │ ├── label_connected_blobs_abstract.h │ │ ├── lbp.h │ │ ├── lbp_abstract.h │ │ ├── morphological_operations.h │ │ ├── morphological_operations_abstract.h │ │ ├── random_color_transform.h │ │ ├── random_color_transform_abstract.h │ │ ├── random_cropper.h │ │ ├── random_cropper_abstract.h │ │ ├── segment_image.h │ │ ├── segment_image_abstract.h │ │ ├── spatial_filtering.h │ │ ├── spatial_filtering_abstract.h │ │ ├── thresholding.h │ │ └── thresholding_abstract.h │ ├── interfaces │ │ ├── cmd_line_parser_option.h │ │ ├── enumerable.h │ │ ├── map_pair.h │ │ └── remover.h │ ├── iomanip │ ├── iosfwd │ ├── iosockstream.h │ ├── iosockstream │ │ ├── iosockstream.h │ │ └── iosockstream_abstract.h │ ├── iostream │ ├── is_kind.h │ ├── istream │ ├── java │ │ ├── CMakeLists.txt │ │ ├── cmake_swig_jni │ │ ├── java_array.h │ │ ├── run_test.sh │ │ ├── swig_api.h │ │ └── swig_test.java │ ├── linker.h │ ├── linker │ │ ├── linker_kernel_1.cpp │ │ ├── linker_kernel_1.h │ │ └── linker_kernel_abstract.h │ ├── locale │ ├── logger.h │ ├── logger │ │ ├── extra_logger_headers.cpp │ │ ├── extra_logger_headers.h │ │ ├── logger_config_file.cpp │ │ ├── logger_config_file.h │ │ ├── logger_kernel_1.cpp │ │ ├── logger_kernel_1.h │ │ └── logger_kernel_abstract.h │ ├── lsh.h │ ├── lsh │ │ ├── create_random_projection_hash.h │ │ ├── create_random_projection_hash_abstract.h │ │ ├── hashes.h │ │ ├── hashes_abstract.h │ │ ├── projection_hash.h │ │ └── projection_hash_abstract.h │ ├── lz77_buffer.h │ ├── lz77_buffer │ │ ├── lz77_buffer_kernel_1.h │ │ ├── lz77_buffer_kernel_2.h │ │ ├── lz77_buffer_kernel_abstract.h │ │ └── lz77_buffer_kernel_c.h │ ├── lzp_buffer.h │ ├── lzp_buffer │ │ ├── lzp_buffer_kernel_1.h │ │ ├── lzp_buffer_kernel_2.h │ │ ├── lzp_buffer_kernel_abstract.h │ │ └── lzp_buffer_kernel_c.h │ ├── manifold_regularization.h │ ├── manifold_regularization │ │ ├── linear_manifold_regularizer.h │ │ └── linear_manifold_regularizer_abstract.h │ ├── map.h │ ├── map │ │ ├── map_kernel_1.h │ │ ├── map_kernel_abstract.h │ │ └── map_kernel_c.h │ ├── matlab │ │ ├── CMakeLists.txt │ │ ├── README.txt │ │ ├── call_matlab.h │ │ ├── cmake_mex_wrapper │ │ ├── example.m │ │ ├── example_mex_callback.cpp │ │ ├── example_mex_class.cpp │ │ ├── example_mex_function.cpp │ │ ├── example_mex_struct.cpp │ │ ├── mex_wrapper.cpp │ │ ├── subprocess_stream.cpp │ │ └── subprocess_stream.h │ ├── matrix.h │ ├── matrix │ │ ├── cblas_constants.h │ │ ├── lapack │ │ │ ├── fortran_id.h │ │ │ ├── gees.h │ │ │ ├── geev.h │ │ │ ├── geqrf.h │ │ │ ├── gesdd.h │ │ │ ├── gesvd.h │ │ │ ├── getrf.h │ │ │ ├── ormqr.h │ │ │ ├── pbtrf.h │ │ │ ├── potrf.h │ │ │ ├── syev.h │ │ │ └── syevr.h │ │ ├── matrix.h │ │ ├── matrix_abstract.h │ │ ├── matrix_assign.h │ │ ├── matrix_assign_fwd.h │ │ ├── matrix_blas_bindings.h │ │ ├── matrix_cholesky.h │ │ ├── matrix_conj_trans.h │ │ ├── matrix_conv.h │ │ ├── matrix_conv_abstract.h │ │ ├── matrix_data_layout.h │ │ ├── matrix_data_layout_abstract.h │ │ ├── matrix_default_mul.h │ │ ├── matrix_eigenvalue.h │ │ ├── matrix_exp.h │ │ ├── matrix_exp_abstract.h │ │ ├── matrix_expressions.h │ │ ├── matrix_fft.h │ │ ├── matrix_fft_abstract.h │ │ ├── matrix_fwd.h │ │ ├── matrix_generic_image.h │ │ ├── matrix_la.h │ │ ├── matrix_la_abstract.h │ │ ├── matrix_lu.h │ │ ├── matrix_mat.h │ │ ├── matrix_mat_abstract.h │ │ ├── matrix_math_functions.h │ │ ├── matrix_math_functions_abstract.h │ │ ├── matrix_op.h │ │ ├── matrix_qr.h │ │ ├── matrix_read_from_istream.h │ │ ├── matrix_subexp.h │ │ ├── matrix_subexp_abstract.h │ │ ├── matrix_trsm.h │ │ ├── matrix_utilities.h │ │ ├── matrix_utilities_abstract.h │ │ ├── symmetric_matrix_cache.h │ │ └── symmetric_matrix_cache_abstract.h │ ├── md5.h │ ├── md5 │ │ ├── md5_kernel_1.cpp │ │ ├── md5_kernel_1.h │ │ └── md5_kernel_abstract.h │ ├── member_function_pointer.h │ ├── member_function_pointer │ │ ├── make_mfp.h │ │ ├── make_mfp_abstract.h │ │ ├── member_function_pointer_kernel_1.h │ │ └── member_function_pointer_kernel_abstract.h │ ├── memory_manager.h │ ├── memory_manager │ │ ├── memory_manager_kernel_1.h │ │ ├── memory_manager_kernel_2.h │ │ ├── memory_manager_kernel_3.h │ │ └── memory_manager_kernel_abstract.h │ ├── memory_manager_global.h │ ├── memory_manager_global │ │ ├── memory_manager_global_kernel_1.h │ │ └── memory_manager_global_kernel_abstract.h │ ├── memory_manager_stateless.h │ ├── memory_manager_stateless │ │ ├── memory_manager_stateless_kernel_1.h │ │ ├── memory_manager_stateless_kernel_2.h │ │ └── memory_manager_stateless_kernel_abstract.h │ ├── metaprogramming.h │ ├── misc_api.h │ ├── misc_api │ │ ├── misc_api_kernel_1.cpp │ │ ├── misc_api_kernel_1.h │ │ ├── misc_api_kernel_2.cpp │ │ ├── misc_api_kernel_2.h │ │ ├── misc_api_kernel_abstract.h │ │ ├── misc_api_shared.h │ │ ├── posix.h │ │ └── windows.h │ ├── mlp.h │ ├── mlp │ │ ├── mlp_kernel_1.h │ │ ├── mlp_kernel_abstract.h │ │ └── mlp_kernel_c.h │ ├── noncopyable.h │ ├── numeric_constants.h │ ├── numerical_integration.h │ ├── numerical_integration │ │ ├── integrate_function_adapt_simpson.h │ │ └── integrate_function_adapt_simpson_abstract.h │ ├── opencv.h │ ├── opencv │ │ ├── cv_image.h │ │ ├── cv_image_abstract.h │ │ ├── to_open_cv.h │ │ └── to_open_cv_abstract.h │ ├── optimization.h │ ├── optimization │ │ ├── elastic_net.h │ │ ├── elastic_net_abstract.h │ │ ├── find_max_factor_graph_nmplp.h │ │ ├── find_max_factor_graph_nmplp_abstract.h │ │ ├── find_max_factor_graph_viterbi.h │ │ ├── find_max_factor_graph_viterbi_abstract.h │ │ ├── find_max_parse_cky.h │ │ ├── find_max_parse_cky_abstract.h │ │ ├── find_optimal_parameters.h │ │ ├── find_optimal_parameters_abstract.h │ │ ├── isotonic_regression.h │ │ ├── isotonic_regression_abstract.h │ │ ├── max_cost_assignment.h │ │ ├── max_cost_assignment_abstract.h │ │ ├── max_sum_submatrix.h │ │ ├── max_sum_submatrix_abstract.h │ │ ├── optimization.h │ │ ├── optimization_abstract.h │ │ ├── optimization_bobyqa.h │ │ ├── optimization_bobyqa_abstract.h │ │ ├── optimization_least_squares.h │ │ ├── optimization_least_squares_abstract.h │ │ ├── optimization_line_search.h │ │ ├── optimization_line_search_abstract.h │ │ ├── optimization_oca.h │ │ ├── optimization_oca_abstract.h │ │ ├── optimization_search_strategies.h │ │ ├── optimization_search_strategies_abstract.h │ │ ├── optimization_solve_qp2_using_smo.h │ │ ├── optimization_solve_qp2_using_smo_abstract.h │ │ ├── optimization_solve_qp3_using_smo.h │ │ ├── optimization_solve_qp3_using_smo_abstract.h │ │ ├── optimization_solve_qp_using_smo.h │ │ ├── optimization_solve_qp_using_smo_abstract.h │ │ ├── optimization_stop_strategies.h │ │ ├── optimization_stop_strategies_abstract.h │ │ ├── optimization_trust_region.h │ │ └── optimization_trust_region_abstract.h │ ├── ostream │ ├── pipe.h │ ├── pipe │ │ ├── pipe_kernel_1.h │ │ └── pipe_kernel_abstract.h │ ├── pixel.h │ ├── platform.h │ ├── python.h │ ├── python │ │ ├── numpy_image.h │ │ ├── pyassert.h │ │ ├── pybind_utils.h │ │ └── serialize_pickle.h │ ├── quantum_computing.h │ ├── quantum_computing │ │ ├── quantum_computing.h │ │ └── quantum_computing_abstract.h │ ├── queue.h │ ├── queue │ │ ├── queue_kernel_1.h │ │ ├── queue_kernel_2.h │ │ ├── queue_kernel_abstract.h │ │ ├── queue_kernel_c.h │ │ ├── queue_sort_1.h │ │ └── queue_sort_abstract.h │ ├── rand.h │ ├── rand │ │ ├── mersenne_twister.h │ │ ├── rand_kernel_1.h │ │ └── rand_kernel_abstract.h │ ├── random_forest.h │ ├── random_forest │ │ ├── random_forest_regression.h │ │ └── random_forest_regression_abstract.h │ ├── ref.h │ ├── reference_counter.h │ ├── reference_counter │ │ ├── reference_counter_kernel_1.h │ │ └── reference_counter_kernel_abstract.h │ ├── revision.h │ ├── revision.h.in │ ├── sequence.h │ ├── sequence │ │ ├── sequence_compare_1.h │ │ ├── sequence_compare_abstract.h │ │ ├── sequence_kernel_1.h │ │ ├── sequence_kernel_2.h │ │ ├── sequence_kernel_abstract.h │ │ ├── sequence_kernel_c.h │ │ ├── sequence_sort_1.h │ │ ├── sequence_sort_2.h │ │ └── sequence_sort_abstract.h │ ├── serialize.h │ ├── server.h │ ├── server │ │ ├── server_http.cpp │ │ ├── server_http.h │ │ ├── server_http_abstract.h │ │ ├── server_iostream.cpp │ │ ├── server_iostream.h │ │ ├── server_iostream_abstract.h │ │ ├── server_kernel.cpp │ │ ├── server_kernel.h │ │ └── server_kernel_abstract.h │ ├── set.h │ ├── set │ │ ├── set_compare_1.h │ │ ├── set_compare_abstract.h │ │ ├── set_kernel_1.h │ │ ├── set_kernel_abstract.h │ │ └── set_kernel_c.h │ ├── set_utils.h │ ├── set_utils │ │ ├── set_utils.h │ │ └── set_utils_abstract.h │ ├── simd.h │ ├── simd │ │ ├── simd4f.h │ │ ├── simd4i.h │ │ ├── simd8f.h │ │ ├── simd8i.h │ │ └── simd_check.h │ ├── sliding_buffer.h │ ├── sliding_buffer │ │ ├── circular_buffer.h │ │ ├── circular_buffer_abstract.h │ │ ├── sliding_buffer_kernel_1.h │ │ ├── sliding_buffer_kernel_abstract.h │ │ └── sliding_buffer_kernel_c.h │ ├── smart_pointers.h │ ├── smart_pointers │ │ ├── scoped_ptr.h │ │ ├── shared_ptr.h │ │ ├── shared_ptr_abstract.h │ │ ├── shared_ptr_thread_safe.h │ │ ├── shared_ptr_thread_safe_abstract.h │ │ ├── weak_ptr.h │ │ └── weak_ptr_abstract.h │ ├── smart_pointers_thread_safe.h │ ├── sockets.h │ ├── sockets │ │ ├── posix.h │ │ ├── sockets_extensions.cpp │ │ ├── sockets_extensions.h │ │ ├── sockets_extensions_abstract.h │ │ ├── sockets_kernel_1.cpp │ │ ├── sockets_kernel_1.h │ │ ├── sockets_kernel_2.cpp │ │ ├── sockets_kernel_2.h │ │ ├── sockets_kernel_abstract.h │ │ └── windows.h │ ├── sockstreambuf.h │ ├── sockstreambuf │ │ ├── sockstreambuf.cpp │ │ ├── sockstreambuf.h │ │ ├── sockstreambuf_abstract.h │ │ ├── sockstreambuf_unbuffered.cpp │ │ └── sockstreambuf_unbuffered.h │ ├── sort.h │ ├── sparse_vector.h │ ├── sqlite.h │ ├── sqlite │ │ ├── sqlite.h │ │ ├── sqlite_abstract.h │ │ ├── sqlite_tools.h │ │ └── sqlite_tools_abstract.h │ ├── sstream │ ├── stack.h │ ├── stack │ │ ├── stack_kernel_1.h │ │ ├── stack_kernel_abstract.h │ │ └── stack_kernel_c.h │ ├── stack_trace.cpp │ ├── stack_trace.h │ ├── static_map.h │ ├── static_map │ │ ├── static_map_kernel_1.h │ │ ├── static_map_kernel_abstract.h │ │ └── static_map_kernel_c.h │ ├── static_set.h │ ├── static_set │ │ ├── static_set_compare_1.h │ │ ├── static_set_compare_abstract.h │ │ ├── static_set_kernel_1.h │ │ ├── static_set_kernel_abstract.h │ │ └── static_set_kernel_c.h │ ├── statistics.h │ ├── statistics │ │ ├── average_precision.h │ │ ├── average_precision_abstract.h │ │ ├── cca.h │ │ ├── cca_abstract.h │ │ ├── dpca.h │ │ ├── dpca_abstract.h │ │ ├── image_feature_sampling.h │ │ ├── image_feature_sampling_abstract.h │ │ ├── lda.h │ │ ├── lda_abstract.h │ │ ├── random_subset_selector.h │ │ ├── random_subset_selector_abstract.h │ │ ├── running_gradient.h │ │ ├── running_gradient_abstract.h │ │ ├── sammon.h │ │ ├── sammon_abstract.h │ │ ├── statistics.h │ │ ├── statistics_abstract.h │ │ ├── vector_normalizer_frobmetric.h │ │ └── vector_normalizer_frobmetric_abstract.h │ ├── std_allocator.h │ ├── stl_checked.h │ ├── stl_checked │ │ ├── std_vector_c.h │ │ └── std_vector_c_abstract.h │ ├── string.h │ ├── string │ │ ├── cassert │ │ ├── iomanip │ │ ├── iosfwd │ │ ├── iostream │ │ ├── locale │ │ ├── string.h │ │ └── string_abstract.h │ ├── svm.h │ ├── svm │ │ ├── active_learning.h │ │ ├── active_learning_abstract.h │ │ ├── assignment_function.h │ │ ├── assignment_function_abstract.h │ │ ├── auto.cpp │ │ ├── auto.h │ │ ├── auto_abstract.h │ │ ├── cross_validate_assignment_trainer.h │ │ ├── cross_validate_assignment_trainer_abstract.h │ │ ├── cross_validate_graph_labeling_trainer.h │ │ ├── cross_validate_graph_labeling_trainer_abstract.h │ │ ├── cross_validate_multiclass_trainer.h │ │ ├── cross_validate_multiclass_trainer_abstract.h │ │ ├── cross_validate_object_detection_trainer.h │ │ ├── cross_validate_object_detection_trainer_abstract.h │ │ ├── cross_validate_regression_trainer.h │ │ ├── cross_validate_regression_trainer_abstract.h │ │ ├── cross_validate_sequence_labeler.h │ │ ├── cross_validate_sequence_labeler_abstract.h │ │ ├── cross_validate_sequence_segmenter.h │ │ ├── cross_validate_sequence_segmenter_abstract.h │ │ ├── cross_validate_track_association_trainer.h │ │ ├── cross_validate_track_association_trainer_abstract.h │ │ ├── empirical_kernel_map.h │ │ ├── empirical_kernel_map_abstract.h │ │ ├── feature_ranking.h │ │ ├── feature_ranking_abstract.h │ │ ├── function.h │ │ ├── function_abstract.h │ │ ├── kcentroid.h │ │ ├── kcentroid_abstract.h │ │ ├── kcentroid_overloads.h │ │ ├── kernel.h │ │ ├── kernel_abstract.h │ │ ├── kernel_matrix.h │ │ ├── kernel_matrix_abstract.h │ │ ├── kkmeans.h │ │ ├── kkmeans_abstract.h │ │ ├── krls.h │ │ ├── krls_abstract.h │ │ ├── krr_trainer.h │ │ ├── krr_trainer_abstract.h │ │ ├── linearly_independent_subset_finder.h │ │ ├── linearly_independent_subset_finder_abstract.h │ │ ├── multiclass_tools.h │ │ ├── multiclass_tools_abstract.h │ │ ├── null_df.h │ │ ├── null_trainer.h │ │ ├── null_trainer_abstract.h │ │ ├── num_nonnegative_weights.h │ │ ├── one_vs_all_decision_function.h │ │ ├── one_vs_all_decision_function_abstract.h │ │ ├── one_vs_all_trainer.h │ │ ├── one_vs_all_trainer_abstract.h │ │ ├── one_vs_one_decision_function.h │ │ ├── one_vs_one_decision_function_abstract.h │ │ ├── one_vs_one_trainer.h │ │ ├── one_vs_one_trainer_abstract.h │ │ ├── pegasos.h │ │ ├── pegasos_abstract.h │ │ ├── ranking_tools.h │ │ ├── ranking_tools_abstract.h │ │ ├── rbf_network.h │ │ ├── rbf_network_abstract.h │ │ ├── reduced.h │ │ ├── reduced_abstract.h │ │ ├── rls.h │ │ ├── rls_abstract.h │ │ ├── roc_trainer.h │ │ ├── roc_trainer_abstract.h │ │ ├── rr_trainer.h │ │ ├── rr_trainer_abstract.h │ │ ├── rvm.h │ │ ├── rvm_abstract.h │ │ ├── sequence_labeler.h │ │ ├── sequence_labeler_abstract.h │ │ ├── sequence_segmenter.h │ │ ├── sequence_segmenter_abstract.h │ │ ├── simplify_linear_decision_function.h │ │ ├── simplify_linear_decision_function_abstract.h │ │ ├── sort_basis_vectors.h │ │ ├── sort_basis_vectors_abstract.h │ │ ├── sparse_kernel.h │ │ ├── sparse_kernel_abstract.h │ │ ├── sparse_vector.h │ │ ├── sparse_vector_abstract.h │ │ ├── structural_assignment_trainer.h │ │ ├── structural_assignment_trainer_abstract.h │ │ ├── structural_graph_labeling_trainer.h │ │ ├── structural_graph_labeling_trainer_abstract.h │ │ ├── structural_object_detection_trainer.h │ │ ├── structural_object_detection_trainer_abstract.h │ │ ├── structural_sequence_labeling_trainer.h │ │ ├── structural_sequence_labeling_trainer_abstract.h │ │ ├── structural_sequence_segmentation_trainer.h │ │ ├── structural_sequence_segmentation_trainer_abstract.h │ │ ├── structural_svm_assignment_problem.h │ │ ├── structural_svm_assignment_problem_abstract.h │ │ ├── structural_svm_distributed.h │ │ ├── structural_svm_distributed_abstract.h │ │ ├── structural_svm_graph_labeling_problem.h │ │ ├── structural_svm_graph_labeling_problem_abstract.h │ │ ├── structural_svm_object_detection_problem.h │ │ ├── structural_svm_object_detection_problem_abstract.h │ │ ├── structural_svm_problem.h │ │ ├── structural_svm_problem_abstract.h │ │ ├── structural_svm_problem_threaded.h │ │ ├── structural_svm_problem_threaded_abstract.h │ │ ├── structural_svm_sequence_labeling_problem.h │ │ ├── structural_svm_sequence_labeling_problem_abstract.h │ │ ├── structural_track_association_trainer.h │ │ ├── structural_track_association_trainer_abstract.h │ │ ├── svm.h │ │ ├── svm_abstract.h │ │ ├── svm_c_ekm_trainer.h │ │ ├── svm_c_ekm_trainer_abstract.h │ │ ├── svm_c_linear_dcd_trainer.h │ │ ├── svm_c_linear_dcd_trainer_abstract.h │ │ ├── svm_c_linear_trainer.h │ │ ├── svm_c_linear_trainer_abstract.h │ │ ├── svm_c_trainer.h │ │ ├── svm_c_trainer_abstract.h │ │ ├── svm_multiclass_linear_trainer.h │ │ ├── svm_multiclass_linear_trainer_abstract.h │ │ ├── svm_nu_trainer.h │ │ ├── svm_nu_trainer_abstract.h │ │ ├── svm_one_class_trainer.h │ │ ├── svm_one_class_trainer_abstract.h │ │ ├── svm_rank_trainer.h │ │ ├── svm_rank_trainer_abstract.h │ │ ├── svm_threaded.h │ │ ├── svm_threaded_abstract.h │ │ ├── svr_linear_trainer.h │ │ ├── svr_linear_trainer_abstract.h │ │ ├── svr_trainer.h │ │ ├── svr_trainer_abstract.h │ │ ├── track_association_function.h │ │ └── track_association_function_abstract.h │ ├── svm_threaded.h │ ├── sync_extension.h │ ├── sync_extension │ │ ├── sync_extension_kernel_1.h │ │ └── sync_extension_kernel_abstract.h │ ├── test │ │ ├── CMakeLists.txt │ │ ├── WINDOWS_build_and_run_all_unit_tests.bat │ │ ├── active_learning.cpp │ │ ├── any.cpp │ │ ├── any_function.cpp │ │ ├── array.cpp │ │ ├── array2d.cpp │ │ ├── assignment_learning.cpp │ │ ├── base64.cpp │ │ ├── bayes_nets.cpp │ │ ├── bigint.cpp │ │ ├── binary_search_tree.h │ │ ├── binary_search_tree_kernel_1a.cpp │ │ ├── binary_search_tree_kernel_2a.cpp │ │ ├── binary_search_tree_mm1.cpp │ │ ├── binary_search_tree_mm2.cpp │ │ ├── blas_bindings │ │ │ ├── CMakeLists.txt │ │ │ ├── blas_bindings_dot.cpp │ │ │ ├── blas_bindings_gemm.cpp │ │ │ ├── blas_bindings_gemv.cpp │ │ │ ├── blas_bindings_ger.cpp │ │ │ ├── blas_bindings_scal_axpy.cpp │ │ │ └── vector.cpp │ │ ├── bridge.cpp │ │ ├── bsp.cpp │ │ ├── byte_orderer.cpp │ │ ├── cca.cpp │ │ ├── checkerboard.h │ │ ├── clustering.cpp │ │ ├── cmd_line_parser.cpp │ │ ├── cmd_line_parser.h │ │ ├── cmd_line_parser_wchar_t.cpp │ │ ├── compress_stream.cpp │ │ ├── conditioning_class.cpp │ │ ├── conditioning_class.h │ │ ├── conditioning_class_c.cpp │ │ ├── config_reader.cpp │ │ ├── correlation_tracker.cpp │ │ ├── crc32.cpp │ │ ├── create_iris_datafile.cpp │ │ ├── create_iris_datafile.h │ │ ├── cublas.cpp │ │ ├── data_io.cpp │ │ ├── directed_graph.cpp │ │ ├── discriminant_pca.cpp │ │ ├── disjoint_subsets.cpp │ │ ├── disjoint_subsets_sized.cpp │ │ ├── dnn.cpp │ │ ├── ekm_and_lisf.cpp │ │ ├── elastic_net.cpp │ │ ├── empirical_kernel_map.cpp │ │ ├── entropy_coder.cpp │ │ ├── entropy_encoder_model.cpp │ │ ├── example.cpp │ │ ├── example_args.cpp │ │ ├── examples │ │ │ └── CMakeLists.txt │ │ ├── face.cpp │ │ ├── fft.cpp │ │ ├── fhog.cpp │ │ ├── filtering.cpp │ │ ├── find_max_factor_graph_nmplp.cpp │ │ ├── find_max_factor_graph_viterbi.cpp │ │ ├── find_optimal_parameters.cpp │ │ ├── geometry.cpp │ │ ├── global_optimization.cpp │ │ ├── graph.cpp │ │ ├── graph_cuts.cpp │ │ ├── graph_labeler.cpp │ │ ├── gui │ │ │ ├── CMakeLists.txt │ │ │ └── main.cpp │ │ ├── hash.cpp │ │ ├── hash_map.cpp │ │ ├── hash_set.cpp │ │ ├── hash_table.cpp │ │ ├── hog_image.cpp │ │ ├── image.cpp │ │ ├── iosockstream.cpp │ │ ├── is_same_object.cpp │ │ ├── isotonic_regression.cpp │ │ ├── kcentroid.cpp │ │ ├── kernel_matrix.cpp │ │ ├── kmeans.cpp │ │ ├── learning_to_track.cpp │ │ ├── least_squares.cpp │ │ ├── linear_manifold_regularizer.cpp │ │ ├── lspi.cpp │ │ ├── lz77_buffer.cpp │ │ ├── main.cpp │ │ ├── makefile │ │ ├── map.cpp │ │ ├── matrix.cpp │ │ ├── matrix2.cpp │ │ ├── matrix3.cpp │ │ ├── matrix4.cpp │ │ ├── matrix_chol.cpp │ │ ├── matrix_eig.cpp │ │ ├── matrix_lu.cpp │ │ ├── matrix_qr.cpp │ │ ├── max_cost_assignment.cpp │ │ ├── max_sum_submatrix.cpp │ │ ├── md5.cpp │ │ ├── member_function_pointer.cpp │ │ ├── metaprogramming.cpp │ │ ├── mpc.cpp │ │ ├── multithreaded_object.cpp │ │ ├── numerical_integration.cpp │ │ ├── object_detector.cpp │ │ ├── oca.cpp │ │ ├── one_vs_all_trainer.cpp │ │ ├── one_vs_one_trainer.cpp │ │ ├── opt_qp_solver.cpp │ │ ├── optimization.cpp │ │ ├── optimization_test_functions.cpp │ │ ├── optimization_test_functions.h │ │ ├── parallel_for.cpp │ │ ├── parse.cpp │ │ ├── pipe.cpp │ │ ├── pixel.cpp │ │ ├── probabilistic.cpp │ │ ├── pyramid_down.cpp │ │ ├── queue.cpp │ │ ├── rand.cpp │ │ ├── random_forest.cpp │ │ ├── ranking.cpp │ │ ├── read_write_mutex.cpp │ │ ├── reference_counter.cpp │ │ ├── rls.cpp │ │ ├── sammon.cpp │ │ ├── scan_image.cpp │ │ ├── sequence.cpp │ │ ├── sequence_labeler.cpp │ │ ├── sequence_segmenter.cpp │ │ ├── serialize.cpp │ │ ├── set.cpp │ │ ├── sldf.cpp │ │ ├── sliding_buffer.cpp │ │ ├── smart_pointers.cpp │ │ ├── sockets.cpp │ │ ├── sockets2.cpp │ │ ├── sockstreambuf.cpp │ │ ├── sparse_vector.cpp │ │ ├── stack.cpp │ │ ├── static_map.cpp │ │ ├── static_set.cpp │ │ ├── statistics.cpp │ │ ├── std_vector_c.cpp │ │ ├── string.cpp │ │ ├── svm.cpp │ │ ├── svm_c_linear.cpp │ │ ├── svm_c_linear_dcd.cpp │ │ ├── svm_multiclass_linear.cpp │ │ ├── svm_struct.cpp │ │ ├── svr_linear_trainer.cpp │ │ ├── symmetric_matrix_cache.cpp │ │ ├── tester.cpp │ │ ├── tester.h │ │ ├── thread_pool.cpp │ │ ├── threads.cpp │ │ ├── timer.cpp │ │ ├── tokenizer.cpp │ │ ├── tools │ │ │ └── CMakeLists.txt │ │ ├── trust_region.cpp │ │ ├── tuple.cpp │ │ ├── type_safe_union.cpp │ │ └── vectorstream.cpp │ ├── test_for_odr_violations.cpp │ ├── test_for_odr_violations.h │ ├── threads.h │ ├── threads │ │ ├── async.cpp │ │ ├── async.h │ │ ├── async_abstract.h │ │ ├── auto_mutex_extension.h │ │ ├── auto_mutex_extension_abstract.h │ │ ├── auto_unlock_extension.h │ │ ├── auto_unlock_extension_abstract.h │ │ ├── create_new_thread_extension.h │ │ ├── create_new_thread_extension_abstract.h │ │ ├── multithreaded_object_extension.cpp │ │ ├── multithreaded_object_extension.h │ │ ├── multithreaded_object_extension_abstract.h │ │ ├── parallel_for_extension.h │ │ ├── parallel_for_extension_abstract.h │ │ ├── posix.h │ │ ├── read_write_mutex_extension.h │ │ ├── read_write_mutex_extension_abstract.h │ │ ├── rmutex_extension.h │ │ ├── rmutex_extension_abstract.h │ │ ├── rsignaler_extension.h │ │ ├── rsignaler_extension_abstract.h │ │ ├── thread_function_extension.h │ │ ├── thread_function_extension_abstract.h │ │ ├── thread_pool_extension.cpp │ │ ├── thread_pool_extension.h │ │ ├── thread_pool_extension_abstract.h │ │ ├── thread_specific_data_extension.h │ │ ├── thread_specific_data_extension_abstract.h │ │ ├── threaded_object_extension.cpp │ │ ├── threaded_object_extension.h │ │ ├── threaded_object_extension_abstract.h │ │ ├── threads_kernel.h │ │ ├── threads_kernel_1.cpp │ │ ├── threads_kernel_1.h │ │ ├── threads_kernel_2.cpp │ │ ├── threads_kernel_2.h │ │ ├── threads_kernel_abstract.h │ │ ├── threads_kernel_shared.cpp │ │ ├── threads_kernel_shared.h │ │ └── windows.h │ ├── time_this.h │ ├── timeout.h │ ├── timeout │ │ ├── timeout.h │ │ └── timeout_abstract.h │ ├── timer.h │ ├── timer │ │ ├── timer.cpp │ │ ├── timer.h │ │ ├── timer_abstract.h │ │ └── timer_heavy.h │ ├── timing.h │ ├── tokenizer.h │ ├── tokenizer │ │ ├── tokenizer_kernel_1.cpp │ │ ├── tokenizer_kernel_1.h │ │ ├── tokenizer_kernel_abstract.h │ │ └── tokenizer_kernel_c.h │ ├── travis │ │ ├── build-and-test.sh │ │ └── get-old-cmakes.sh │ ├── tuple.h │ ├── tuple │ │ ├── tuple.h │ │ └── tuple_abstract.h │ ├── type_safe_union.h │ ├── type_safe_union │ │ ├── type_safe_union_kernel.h │ │ └── type_safe_union_kernel_abstract.h │ ├── uintn.h │ ├── unicode.h │ ├── unicode │ │ ├── unicode.cpp │ │ ├── unicode.h │ │ └── unicode_abstract.h │ ├── unordered_pair.h │ ├── vectorstream.h │ ├── vectorstream │ │ ├── unserialize.h │ │ ├── unserialize_abstract.h │ │ ├── vectorstream.h │ │ └── vectorstream_abstract.h │ ├── windows_magic.h │ ├── xml_parser.h │ └── xml_parser │ │ ├── xml_parser_kernel_1.h │ │ ├── xml_parser_kernel_abstract.h │ │ └── xml_parser_kernel_interfaces.h ├── landmark_detection.cpp ├── landmark_detection.h ├── stdafx.cpp ├── stdafx.h └── tbb │ ├── aggregator.h │ ├── aligned_space.h │ ├── atomic.h │ ├── blocked_range.h │ ├── blocked_range2d.h │ ├── blocked_range3d.h │ ├── cache_aligned_allocator.h │ ├── combinable.h │ ├── compat │ ├── condition_variable │ ├── ppl.h │ ├── thread │ └── tuple │ ├── concurrent_hash_map.h │ ├── concurrent_lru_cache.h │ ├── concurrent_priority_queue.h │ ├── concurrent_queue.h │ ├── concurrent_unordered_map.h │ ├── concurrent_unordered_set.h │ ├── concurrent_vector.h │ ├── critical_section.h │ ├── enumerable_thread_specific.h │ ├── flow_graph.h │ ├── flow_graph_abstractions.h │ ├── flow_graph_opencl_node.h │ ├── gfx_factory.h │ ├── global_control.h │ ├── index.html │ ├── internal │ ├── _aggregator_impl.h │ ├── _concurrent_queue_impl.h │ ├── _concurrent_unordered_impl.h │ ├── _flow_graph_async_msg_impl.h │ ├── _flow_graph_body_impl.h │ ├── _flow_graph_cache_impl.h │ ├── _flow_graph_impl.h │ ├── _flow_graph_indexer_impl.h │ ├── _flow_graph_item_buffer_impl.h │ ├── _flow_graph_join_impl.h │ ├── _flow_graph_node_impl.h │ ├── _flow_graph_streaming_node.h │ ├── _flow_graph_tagged_buffer_impl.h │ ├── _flow_graph_trace_impl.h │ ├── _flow_graph_types_impl.h │ ├── _mutex_padding.h │ ├── _range_iterator.h │ ├── _tbb_hash_compare_impl.h │ ├── _tbb_strings.h │ ├── _tbb_trace_impl.h │ ├── _tbb_windef.h │ ├── _template_helpers.h │ ├── _x86_eliding_mutex_impl.h │ └── _x86_rtm_rw_mutex_impl.h │ ├── machine │ ├── gcc_armv7.h │ ├── gcc_generic.h │ ├── gcc_ia32_common.h │ ├── gcc_itsx.h │ ├── ibm_aix51.h │ ├── icc_generic.h │ ├── linux_common.h │ ├── linux_ia32.h │ ├── linux_ia64.h │ ├── linux_intel64.h │ ├── mac_ppc.h │ ├── macos_common.h │ ├── mic_common.h │ ├── msvc_armv7.h │ ├── msvc_ia32_common.h │ ├── sunos_sparc.h │ ├── windows_api.h │ ├── windows_ia32.h │ └── windows_intel64.h │ ├── memory_pool.h │ ├── mutex.h │ ├── null_mutex.h │ ├── null_rw_mutex.h │ ├── parallel_do.h │ ├── parallel_for.h │ ├── parallel_for_each.h │ ├── parallel_invoke.h │ ├── parallel_reduce.h │ ├── parallel_scan.h │ ├── parallel_sort.h │ ├── parallel_while.h │ ├── partitioner.h │ ├── pipeline.h │ ├── queuing_mutex.h │ ├── queuing_rw_mutex.h │ ├── reader_writer_lock.h │ ├── recursive_mutex.h │ ├── runtime_loader.h │ ├── scalable_allocator.h │ ├── spin_mutex.h │ ├── spin_rw_mutex.h │ ├── task.h │ ├── task_arena.h │ ├── task_group.h │ ├── task_scheduler_init.h │ ├── task_scheduler_observer.h │ ├── tbb.h │ ├── tbb_allocator.h │ ├── tbb_config.h │ ├── tbb_disable_exceptions.h │ ├── tbb_exception.h │ ├── tbb_machine.h │ ├── tbb_profiling.h │ ├── tbb_stddef.h │ ├── tbb_thread.h │ ├── tbbmalloc_proxy.h │ └── tick_count.h ├── lib ├── dlib.lib └── tbb.lib ├── readme.md ├── res ├── albedo_high.bmp ├── albedo_low.bmp ├── geo_params.txt ├── prog │ ├── 0.bmp │ ├── 1.bmp │ ├── 10.bmp │ ├── 11.bmp │ ├── 12.bmp │ ├── 13.bmp │ ├── 14.bmp │ ├── 15.bmp │ ├── 16.bmp │ ├── 17.bmp │ ├── 18.bmp │ ├── 19.bmp │ ├── 2.bmp │ ├── 20.bmp │ ├── 3.bmp │ ├── 4.bmp │ ├── 5.bmp │ ├── 6.bmp │ ├── 7.bmp │ ├── 8.bmp │ ├── 9.bmp │ └── out.gif ├── reconstruct.bmp ├── relit │ ├── out.gif │ ├── relight_hdr_0.bmp │ ├── relight_hdr_1.bmp │ ├── relight_hdr_10.bmp │ ├── relight_hdr_11.bmp │ ├── relight_hdr_12.bmp │ ├── relight_hdr_13.bmp │ ├── relight_hdr_14.bmp │ ├── relight_hdr_15.bmp │ ├── relight_hdr_16.bmp │ ├── relight_hdr_17.bmp │ ├── relight_hdr_18.bmp │ ├── relight_hdr_19.bmp │ ├── relight_hdr_2.bmp │ ├── relight_hdr_20.bmp │ ├── relight_hdr_3.bmp │ ├── relight_hdr_4.bmp │ ├── relight_hdr_5.bmp │ ├── relight_hdr_6.bmp │ ├── relight_hdr_7.bmp │ ├── relight_hdr_8.bmp │ └── relight_hdr_9.bmp └── render_params.txt ├── res2 ├── albedo_high.bmp ├── albedo_low.bmp ├── geo_params.txt ├── prog │ ├── 0.bmp │ ├── 1.bmp │ ├── 10.bmp │ ├── 11.bmp │ ├── 12.bmp │ ├── 13.bmp │ ├── 14.bmp │ ├── 15.bmp │ ├── 16.bmp │ ├── 17.bmp │ ├── 18.bmp │ ├── 19.bmp │ ├── 2.bmp │ ├── 20.bmp │ ├── 3.bmp │ ├── 4.bmp │ ├── 5.bmp │ ├── 6.bmp │ ├── 7.bmp │ ├── 8.bmp │ ├── 9.bmp │ └── out.gif ├── reconstruct.bmp ├── relit │ ├── out.gif │ ├── relight_hdr_0.bmp │ ├── relight_hdr_1.bmp │ ├── relight_hdr_10.bmp │ ├── relight_hdr_11.bmp │ ├── relight_hdr_12.bmp │ ├── relight_hdr_13.bmp │ ├── relight_hdr_14.bmp │ ├── relight_hdr_15.bmp │ ├── relight_hdr_16.bmp │ ├── relight_hdr_17.bmp │ ├── relight_hdr_18.bmp │ ├── relight_hdr_19.bmp │ ├── relight_hdr_2.bmp │ ├── relight_hdr_20.bmp │ ├── relight_hdr_3.bmp │ ├── relight_hdr_4.bmp │ ├── relight_hdr_5.bmp │ ├── relight_hdr_6.bmp │ ├── relight_hdr_7.bmp │ ├── relight_hdr_8.bmp │ └── relight_hdr_9.bmp └── render_params.txt └── src └── main.cpp /.gitignore: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/.gitignore -------------------------------------------------------------------------------- /FaceRelighting.sln: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/FaceRelighting.sln -------------------------------------------------------------------------------- /FaceRelighting.vcxproj: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/FaceRelighting.vcxproj -------------------------------------------------------------------------------- /FaceRelighting.vcxproj.filters: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/FaceRelighting.vcxproj.filters -------------------------------------------------------------------------------- /FaceRelighting.vcxproj.user: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/FaceRelighting.vcxproj.user -------------------------------------------------------------------------------- /LICENSE: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/LICENSE -------------------------------------------------------------------------------- /data/BFM/convert.py: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/data/BFM/convert.py -------------------------------------------------------------------------------- /data/example/image.png: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/data/example/image.png -------------------------------------------------------------------------------- /data/example/me.jpg: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/data/example/me.jpg -------------------------------------------------------------------------------- /data/model/clm_general.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/data/model/clm_general.txt -------------------------------------------------------------------------------- /data/model/clm_wild.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/data/model/clm_wild.txt -------------------------------------------------------------------------------- /data/model/clnf_general.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/data/model/clnf_general.txt -------------------------------------------------------------------------------- /data/model/clnf_wild.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/data/model/clnf_wild.txt -------------------------------------------------------------------------------- /data/model/haarAlign.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/data/model/haarAlign.txt -------------------------------------------------------------------------------- /data/model/main_clm_general.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/data/model/main_clm_general.txt -------------------------------------------------------------------------------- /data/model/main_clm_wild.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/data/model/main_clm_wild.txt -------------------------------------------------------------------------------- /data/model/main_clnf_general.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/data/model/main_clnf_general.txt -------------------------------------------------------------------------------- /data/model/main_clnf_wild.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/data/model/main_clnf_wild.txt -------------------------------------------------------------------------------- /data/model/model_eye/main_clnf_synth_left.txt: -------------------------------------------------------------------------------- 1 | LandmarkDetector clnf_left_synth.txt -------------------------------------------------------------------------------- /data/model/model_eye/main_clnf_synth_right.txt: -------------------------------------------------------------------------------- 1 | LandmarkDetector clnf_right_synth.txt -------------------------------------------------------------------------------- /data/model/model_inner/clnf_inner.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/data/model/model_inner/clnf_inner.txt -------------------------------------------------------------------------------- /data/model/model_inner/main_clnf_inner.txt: -------------------------------------------------------------------------------- 1 | LandmarkDetector clnf_inner.txt -------------------------------------------------------------------------------- /data/model/tris_68.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/data/model/tris_68.txt -------------------------------------------------------------------------------- /data/model/tris_68_full.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/data/model/tris_68_full.txt -------------------------------------------------------------------------------- /documentation/documentation.pdf: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/documentation/documentation.pdf -------------------------------------------------------------------------------- /include/BFM.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/BFM.cpp -------------------------------------------------------------------------------- /include/BFM.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/BFM.h -------------------------------------------------------------------------------- /include/BFM2Pixel.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/BFM2Pixel.cpp -------------------------------------------------------------------------------- /include/BFM2Pixel.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/BFM2Pixel.h -------------------------------------------------------------------------------- /include/Eigen/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/CMakeLists.txt -------------------------------------------------------------------------------- /include/Eigen/Cholesky: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/Cholesky -------------------------------------------------------------------------------- /include/Eigen/CholmodSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/CholmodSupport -------------------------------------------------------------------------------- /include/Eigen/Core: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/Core -------------------------------------------------------------------------------- /include/Eigen/Dense: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/Dense -------------------------------------------------------------------------------- /include/Eigen/Eigen: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/Eigen -------------------------------------------------------------------------------- /include/Eigen/Eigenvalues: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/Eigenvalues -------------------------------------------------------------------------------- /include/Eigen/Geometry: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/Geometry -------------------------------------------------------------------------------- /include/Eigen/Householder: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/Householder -------------------------------------------------------------------------------- /include/Eigen/IterativeLinearSolvers: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/IterativeLinearSolvers -------------------------------------------------------------------------------- /include/Eigen/Jacobi: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/Jacobi -------------------------------------------------------------------------------- /include/Eigen/LU: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/LU -------------------------------------------------------------------------------- /include/Eigen/MetisSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/MetisSupport -------------------------------------------------------------------------------- /include/Eigen/OrderingMethods: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/OrderingMethods -------------------------------------------------------------------------------- /include/Eigen/PaStiXSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/PaStiXSupport -------------------------------------------------------------------------------- /include/Eigen/PardisoSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/PardisoSupport -------------------------------------------------------------------------------- /include/Eigen/QR: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/QR -------------------------------------------------------------------------------- /include/Eigen/QtAlignedMalloc: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/QtAlignedMalloc -------------------------------------------------------------------------------- /include/Eigen/SPQRSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/SPQRSupport -------------------------------------------------------------------------------- /include/Eigen/SVD: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/SVD -------------------------------------------------------------------------------- /include/Eigen/Sparse: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/Sparse -------------------------------------------------------------------------------- /include/Eigen/SparseCholesky: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/SparseCholesky -------------------------------------------------------------------------------- /include/Eigen/SparseCore: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/SparseCore -------------------------------------------------------------------------------- /include/Eigen/SparseLU: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/SparseLU -------------------------------------------------------------------------------- /include/Eigen/SparseQR: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/SparseQR -------------------------------------------------------------------------------- /include/Eigen/StdDeque: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/StdDeque -------------------------------------------------------------------------------- /include/Eigen/StdList: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/StdList -------------------------------------------------------------------------------- /include/Eigen/StdVector: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/StdVector -------------------------------------------------------------------------------- /include/Eigen/SuperLUSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/SuperLUSupport -------------------------------------------------------------------------------- /include/Eigen/UmfPackSupport: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/UmfPackSupport -------------------------------------------------------------------------------- /include/Eigen/src/Cholesky/LDLT.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Cholesky/LDLT.h -------------------------------------------------------------------------------- /include/Eigen/src/Cholesky/LLT.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Cholesky/LLT.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Array.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Array.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/ArrayBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/ArrayBase.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/ArrayWrapper.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/ArrayWrapper.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Assign.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Assign.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Assign_MKL.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Assign_MKL.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/BandMatrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/BandMatrix.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Block.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Block.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/BooleanRedux.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/BooleanRedux.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/CwiseUnaryOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/CwiseUnaryOp.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/DenseBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/DenseBase.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/DenseStorage.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/DenseStorage.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Diagonal.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Diagonal.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Dot.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Dot.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/EigenBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/EigenBase.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Fuzzy.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Fuzzy.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/IO.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/IO.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Inverse.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Inverse.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Map.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Map.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/MapBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/MapBase.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Matrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Matrix.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/MatrixBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/MatrixBase.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/NestByValue.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/NestByValue.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/NoAlias.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/NoAlias.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/NumTraits.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/NumTraits.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Product.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Product.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Random.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Random.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Redux.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Redux.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Ref.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Ref.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Replicate.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Replicate.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Reverse.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Reverse.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Select.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Select.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Solve.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Solve.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/SolverBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/SolverBase.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/StableNorm.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/StableNorm.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Stride.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Stride.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Swap.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Swap.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Transpose.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Transpose.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/VectorBlock.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/VectorBlock.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/VectorwiseOp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/VectorwiseOp.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/Visitor.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/Visitor.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/util/Macros.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/util/Macros.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/util/Memory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/util/Memory.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/util/Meta.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/util/Meta.h -------------------------------------------------------------------------------- /include/Eigen/src/Core/util/NonMPL2.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Core/util/NonMPL2.h -------------------------------------------------------------------------------- /include/Eigen/src/Geometry/Scaling.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Geometry/Scaling.h -------------------------------------------------------------------------------- /include/Eigen/src/Geometry/Umeyama.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Geometry/Umeyama.h -------------------------------------------------------------------------------- /include/Eigen/src/Jacobi/Jacobi.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/Jacobi/Jacobi.h -------------------------------------------------------------------------------- /include/Eigen/src/LU/Determinant.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/LU/Determinant.h -------------------------------------------------------------------------------- /include/Eigen/src/LU/FullPivLU.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/LU/FullPivLU.h -------------------------------------------------------------------------------- /include/Eigen/src/LU/InverseImpl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/LU/InverseImpl.h -------------------------------------------------------------------------------- /include/Eigen/src/LU/PartialPivLU.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/LU/PartialPivLU.h -------------------------------------------------------------------------------- /include/Eigen/src/QR/HouseholderQR.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/QR/HouseholderQR.h -------------------------------------------------------------------------------- /include/Eigen/src/SVD/BDCSVD.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/SVD/BDCSVD.h -------------------------------------------------------------------------------- /include/Eigen/src/SVD/JacobiSVD.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/SVD/JacobiSVD.h -------------------------------------------------------------------------------- /include/Eigen/src/SVD/SVDBase.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/SVD/SVDBase.h -------------------------------------------------------------------------------- /include/Eigen/src/SparseLU/SparseLU.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/SparseLU/SparseLU.h -------------------------------------------------------------------------------- /include/Eigen/src/SparseQR/SparseQR.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/SparseQR/SparseQR.h -------------------------------------------------------------------------------- /include/Eigen/src/misc/Image.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/misc/Image.h -------------------------------------------------------------------------------- /include/Eigen/src/misc/Kernel.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/misc/Kernel.h -------------------------------------------------------------------------------- /include/Eigen/src/misc/RealSvd2x2.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/misc/RealSvd2x2.h -------------------------------------------------------------------------------- /include/Eigen/src/misc/blas.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/misc/blas.h -------------------------------------------------------------------------------- /include/Eigen/src/misc/lapack.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/misc/lapack.h -------------------------------------------------------------------------------- /include/Eigen/src/misc/lapacke.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/Eigen/src/misc/lapacke.h -------------------------------------------------------------------------------- /include/color_propagation.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/color_propagation.cpp -------------------------------------------------------------------------------- /include/color_propagation.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/color_propagation.h -------------------------------------------------------------------------------- /include/common.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/common.cpp -------------------------------------------------------------------------------- /include/common.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/common.h -------------------------------------------------------------------------------- /include/geometry_fit.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/geometry_fit.cpp -------------------------------------------------------------------------------- /include/geometry_fit.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/geometry_fit.h -------------------------------------------------------------------------------- /include/image.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/image.cpp -------------------------------------------------------------------------------- /include/image.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/image.h -------------------------------------------------------------------------------- /include/landmark.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/landmark.cpp -------------------------------------------------------------------------------- /include/landmark.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/landmark.h -------------------------------------------------------------------------------- /include/math_vec.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/math_vec.cpp -------------------------------------------------------------------------------- /include/math_vec.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/math_vec.h -------------------------------------------------------------------------------- /include/mesh.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/mesh.cpp -------------------------------------------------------------------------------- /include/mesh.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/mesh.h -------------------------------------------------------------------------------- /include/parameter.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/parameter.h -------------------------------------------------------------------------------- /include/specular_removal_grad.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/specular_removal_grad.cpp -------------------------------------------------------------------------------- /include/specular_removal_grad.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/specular_removal_grad.h -------------------------------------------------------------------------------- /include/tex_light_fit.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/tex_light_fit.cpp -------------------------------------------------------------------------------- /include/tex_light_fit.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/tex_light_fit.h -------------------------------------------------------------------------------- /include/tinyexr.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/tinyexr.h -------------------------------------------------------------------------------- /include/unsupported/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/CMakeLists.txt -------------------------------------------------------------------------------- /include/unsupported/Eigen/AutoDiff: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/Eigen/AutoDiff -------------------------------------------------------------------------------- /include/unsupported/Eigen/BVH: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/Eigen/BVH -------------------------------------------------------------------------------- /include/unsupported/Eigen/EulerAngles: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/Eigen/EulerAngles -------------------------------------------------------------------------------- /include/unsupported/Eigen/FFT: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/Eigen/FFT -------------------------------------------------------------------------------- /include/unsupported/Eigen/Polynomials: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/Eigen/Polynomials -------------------------------------------------------------------------------- /include/unsupported/Eigen/Skyline: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/Eigen/Skyline -------------------------------------------------------------------------------- /include/unsupported/Eigen/SparseExtra: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/Eigen/SparseExtra -------------------------------------------------------------------------------- /include/unsupported/Eigen/Splines: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/Eigen/Splines -------------------------------------------------------------------------------- /include/unsupported/README.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/README.txt -------------------------------------------------------------------------------- /include/unsupported/doc/Overview.dox: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/doc/Overview.dox -------------------------------------------------------------------------------- /include/unsupported/test/BVH.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/test/BVH.cpp -------------------------------------------------------------------------------- /include/unsupported/test/FFT.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/test/FFT.cpp -------------------------------------------------------------------------------- /include/unsupported/test/FFTW.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/test/FFTW.cpp -------------------------------------------------------------------------------- /include/unsupported/test/autodiff.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/test/autodiff.cpp -------------------------------------------------------------------------------- /include/unsupported/test/dgmres.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/test/dgmres.cpp -------------------------------------------------------------------------------- /include/unsupported/test/gmres.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/test/gmres.cpp -------------------------------------------------------------------------------- /include/unsupported/test/minres.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/test/minres.cpp -------------------------------------------------------------------------------- /include/unsupported/test/splines.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/include/unsupported/test/splines.cpp -------------------------------------------------------------------------------- /landmark/CCNF_patch_expert.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/CCNF_patch_expert.cpp -------------------------------------------------------------------------------- /landmark/CCNF_patch_expert.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/CCNF_patch_expert.h -------------------------------------------------------------------------------- /landmark/LandmarkCoreIncludes.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/LandmarkCoreIncludes.h -------------------------------------------------------------------------------- /landmark/LandmarkDetectionValidator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/LandmarkDetectionValidator.h -------------------------------------------------------------------------------- /landmark/LandmarkDetectorFunc.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/LandmarkDetectorFunc.cpp -------------------------------------------------------------------------------- /landmark/LandmarkDetectorFunc.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/LandmarkDetectorFunc.h -------------------------------------------------------------------------------- /landmark/LandmarkDetectorModel.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/LandmarkDetectorModel.cpp -------------------------------------------------------------------------------- /landmark/LandmarkDetectorModel.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/LandmarkDetectorModel.h -------------------------------------------------------------------------------- /landmark/LandmarkDetectorParameters.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/LandmarkDetectorParameters.h -------------------------------------------------------------------------------- /landmark/LandmarkDetectorUtils.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/LandmarkDetectorUtils.cpp -------------------------------------------------------------------------------- /landmark/LandmarkDetectorUtils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/LandmarkDetectorUtils.h -------------------------------------------------------------------------------- /landmark/PAW.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/PAW.cpp -------------------------------------------------------------------------------- /landmark/PAW.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/PAW.h -------------------------------------------------------------------------------- /landmark/PDM.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/PDM.cpp -------------------------------------------------------------------------------- /landmark/PDM.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/PDM.h -------------------------------------------------------------------------------- /landmark/Patch_experts.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/Patch_experts.cpp -------------------------------------------------------------------------------- /landmark/Patch_experts.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/Patch_experts.h -------------------------------------------------------------------------------- /landmark/SVR_patch_expert.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/SVR_patch_expert.cpp -------------------------------------------------------------------------------- /landmark/SVR_patch_expert.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/SVR_patch_expert.h -------------------------------------------------------------------------------- /landmark/dlib/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/CMakeLists.txt -------------------------------------------------------------------------------- /landmark/dlib/LICENSE.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/LICENSE.txt -------------------------------------------------------------------------------- /landmark/dlib/algs.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/algs.h -------------------------------------------------------------------------------- /landmark/dlib/all/source.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/all/source.cpp -------------------------------------------------------------------------------- /landmark/dlib/any.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/any.h -------------------------------------------------------------------------------- /landmark/dlib/any/any.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/any/any.h -------------------------------------------------------------------------------- /landmark/dlib/any/any_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/any/any_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/any/any_function.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/any/any_function.h -------------------------------------------------------------------------------- /landmark/dlib/any/any_function_impl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/any/any_function_impl.h -------------------------------------------------------------------------------- /landmark/dlib/any/any_trainer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/any/any_trainer.h -------------------------------------------------------------------------------- /landmark/dlib/appveyor/dtest.yml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/appveyor/dtest.yml -------------------------------------------------------------------------------- /landmark/dlib/appveyor/examples.yml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/appveyor/examples.yml -------------------------------------------------------------------------------- /landmark/dlib/appveyor/python.yml: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/appveyor/python.yml -------------------------------------------------------------------------------- /landmark/dlib/array.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/array.h -------------------------------------------------------------------------------- /landmark/dlib/array/array_kernel.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/array/array_kernel.h -------------------------------------------------------------------------------- /landmark/dlib/array/array_tools.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/array/array_tools.h -------------------------------------------------------------------------------- /landmark/dlib/array2d.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/array2d.h -------------------------------------------------------------------------------- /landmark/dlib/assert.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/assert.h -------------------------------------------------------------------------------- /landmark/dlib/base64.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/base64.h -------------------------------------------------------------------------------- /landmark/dlib/bayes_utils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/bayes_utils.h -------------------------------------------------------------------------------- /landmark/dlib/bigint.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/bigint.h -------------------------------------------------------------------------------- /landmark/dlib/binary_search_tree.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/binary_search_tree.h -------------------------------------------------------------------------------- /landmark/dlib/bit_stream.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/bit_stream.h -------------------------------------------------------------------------------- /landmark/dlib/bits/c++config.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/bits/c++config.h -------------------------------------------------------------------------------- /landmark/dlib/bridge.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/bridge.h -------------------------------------------------------------------------------- /landmark/dlib/bridge/bridge.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/bridge/bridge.h -------------------------------------------------------------------------------- /landmark/dlib/bsp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/bsp.h -------------------------------------------------------------------------------- /landmark/dlib/bsp/bsp.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/bsp/bsp.cpp -------------------------------------------------------------------------------- /landmark/dlib/bsp/bsp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/bsp/bsp.h -------------------------------------------------------------------------------- /landmark/dlib/bsp/bsp_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/bsp/bsp_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/byte_orderer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/byte_orderer.h -------------------------------------------------------------------------------- /landmark/dlib/cassert: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cassert -------------------------------------------------------------------------------- /landmark/dlib/clustering.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/clustering.h -------------------------------------------------------------------------------- /landmark/dlib/cmake_utils/dlib.pc.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cmake_utils/dlib.pc.in -------------------------------------------------------------------------------- /landmark/dlib/cmake_utils/test_for_avx/this_file_doesnt_compile.cpp: -------------------------------------------------------------------------------- 1 | 2 | #error "This file doesn't compile!" 3 | 4 | -------------------------------------------------------------------------------- /landmark/dlib/cmake_utils/test_for_sse4/this_file_doesnt_compile.cpp: -------------------------------------------------------------------------------- 1 | 2 | #error "This file doesn't compile!" 3 | 4 | -------------------------------------------------------------------------------- /landmark/dlib/cmd_line_parser.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cmd_line_parser.h -------------------------------------------------------------------------------- /landmark/dlib/compress_stream.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/compress_stream.h -------------------------------------------------------------------------------- /landmark/dlib/conditioning_class.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/conditioning_class.h -------------------------------------------------------------------------------- /landmark/dlib/config.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/config.h -------------------------------------------------------------------------------- /landmark/dlib/config.h.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/config.h.in -------------------------------------------------------------------------------- /landmark/dlib/config_reader.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/config_reader.h -------------------------------------------------------------------------------- /landmark/dlib/control.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/control.h -------------------------------------------------------------------------------- /landmark/dlib/control/lspi.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/control/lspi.h -------------------------------------------------------------------------------- /landmark/dlib/control/lspi_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/control/lspi_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/control/mpc.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/control/mpc.h -------------------------------------------------------------------------------- /landmark/dlib/control/mpc_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/control/mpc_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/cpp_pretty_printer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cpp_pretty_printer.h -------------------------------------------------------------------------------- /landmark/dlib/cpp_tokenizer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cpp_tokenizer.h -------------------------------------------------------------------------------- /landmark/dlib/crc32.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/crc32.h -------------------------------------------------------------------------------- /landmark/dlib/crc32/crc32_kernel_1.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/crc32/crc32_kernel_1.h -------------------------------------------------------------------------------- /landmark/dlib/cstring: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cstring -------------------------------------------------------------------------------- /landmark/dlib/cuda/cpu_dlib.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/cpu_dlib.cpp -------------------------------------------------------------------------------- /landmark/dlib/cuda/cpu_dlib.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/cpu_dlib.h -------------------------------------------------------------------------------- /landmark/dlib/cuda/cublas_dlibapi.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/cublas_dlibapi.cpp -------------------------------------------------------------------------------- /landmark/dlib/cuda/cublas_dlibapi.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/cublas_dlibapi.h -------------------------------------------------------------------------------- /landmark/dlib/cuda/cuda_data_ptr.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/cuda_data_ptr.cpp -------------------------------------------------------------------------------- /landmark/dlib/cuda/cuda_data_ptr.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/cuda_data_ptr.h -------------------------------------------------------------------------------- /landmark/dlib/cuda/cuda_dlib.cu: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/cuda_dlib.cu -------------------------------------------------------------------------------- /landmark/dlib/cuda/cuda_dlib.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/cuda_dlib.h -------------------------------------------------------------------------------- /landmark/dlib/cuda/cuda_errors.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/cuda_errors.h -------------------------------------------------------------------------------- /landmark/dlib/cuda/cuda_utils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/cuda_utils.h -------------------------------------------------------------------------------- /landmark/dlib/cuda/cudnn_dlibapi.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/cudnn_dlibapi.cpp -------------------------------------------------------------------------------- /landmark/dlib/cuda/cudnn_dlibapi.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/cudnn_dlibapi.h -------------------------------------------------------------------------------- /landmark/dlib/cuda/curand_dlibapi.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/curand_dlibapi.cpp -------------------------------------------------------------------------------- /landmark/dlib/cuda/curand_dlibapi.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/curand_dlibapi.h -------------------------------------------------------------------------------- /landmark/dlib/cuda/cusolver_dlibapi.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/cusolver_dlibapi.h -------------------------------------------------------------------------------- /landmark/dlib/cuda/gpu_data.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/gpu_data.cpp -------------------------------------------------------------------------------- /landmark/dlib/cuda/gpu_data.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/gpu_data.h -------------------------------------------------------------------------------- /landmark/dlib/cuda/tensor.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/tensor.h -------------------------------------------------------------------------------- /landmark/dlib/cuda/tensor_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/tensor_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/cuda/tensor_tools.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/tensor_tools.cpp -------------------------------------------------------------------------------- /landmark/dlib/cuda/tensor_tools.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/cuda/tensor_tools.h -------------------------------------------------------------------------------- /landmark/dlib/data_io.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/data_io.h -------------------------------------------------------------------------------- /landmark/dlib/data_io/libsvm_io.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/data_io/libsvm_io.h -------------------------------------------------------------------------------- /landmark/dlib/data_io/mnist.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/data_io/mnist.cpp -------------------------------------------------------------------------------- /landmark/dlib/data_io/mnist.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/data_io/mnist.h -------------------------------------------------------------------------------- /landmark/dlib/dir_nav.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dir_nav.h -------------------------------------------------------------------------------- /landmark/dlib/dir_nav/posix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dir_nav/posix.h -------------------------------------------------------------------------------- /landmark/dlib/dir_nav/windows.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dir_nav/windows.h -------------------------------------------------------------------------------- /landmark/dlib/directed_graph.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/directed_graph.h -------------------------------------------------------------------------------- /landmark/dlib/disjoint_subsets.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/disjoint_subsets.h -------------------------------------------------------------------------------- /landmark/dlib/dnn.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dnn.h -------------------------------------------------------------------------------- /landmark/dlib/dnn/core.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dnn/core.h -------------------------------------------------------------------------------- /landmark/dlib/dnn/core_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dnn/core_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/dnn/input.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dnn/input.h -------------------------------------------------------------------------------- /landmark/dlib/dnn/input_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dnn/input_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/dnn/layers.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dnn/layers.h -------------------------------------------------------------------------------- /landmark/dlib/dnn/layers_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dnn/layers_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/dnn/loss.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dnn/loss.h -------------------------------------------------------------------------------- /landmark/dlib/dnn/loss_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dnn/loss_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/dnn/solvers.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dnn/solvers.h -------------------------------------------------------------------------------- /landmark/dlib/dnn/solvers_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dnn/solvers_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/dnn/trainer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dnn/trainer.h -------------------------------------------------------------------------------- /landmark/dlib/dnn/trainer_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dnn/trainer_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/dnn/utilities.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dnn/utilities.h -------------------------------------------------------------------------------- /landmark/dlib/dnn/validation.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/dnn/validation.h -------------------------------------------------------------------------------- /landmark/dlib/enable_if.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/enable_if.h -------------------------------------------------------------------------------- /landmark/dlib/entropy_decoder.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/entropy_decoder.h -------------------------------------------------------------------------------- /landmark/dlib/entropy_decoder_model.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/entropy_decoder_model.h -------------------------------------------------------------------------------- /landmark/dlib/entropy_encoder.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/entropy_encoder.h -------------------------------------------------------------------------------- /landmark/dlib/entropy_encoder_model.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/entropy_encoder_model.h -------------------------------------------------------------------------------- /landmark/dlib/error.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/error.h -------------------------------------------------------------------------------- /landmark/dlib/external/cblas/README: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/cblas/README -------------------------------------------------------------------------------- /landmark/dlib/external/cblas/cblas.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/cblas/cblas.h -------------------------------------------------------------------------------- /landmark/dlib/external/libjpeg/README: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/libjpeg/README -------------------------------------------------------------------------------- /landmark/dlib/external/libjpeg/jdct.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/libjpeg/jdct.h -------------------------------------------------------------------------------- /landmark/dlib/external/libpng/LICENSE: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/libpng/LICENSE -------------------------------------------------------------------------------- /landmark/dlib/external/libpng/README: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/libpng/README -------------------------------------------------------------------------------- /landmark/dlib/external/libpng/png.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/libpng/png.c -------------------------------------------------------------------------------- /landmark/dlib/external/libpng/png.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/libpng/png.h -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/README: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/README -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/adler32.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/adler32.c -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/crc32.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/crc32.c -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/crc32.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/crc32.h -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/deflate.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/deflate.c -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/deflate.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/deflate.h -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/gzclose.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/gzclose.c -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/gzguts.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/gzguts.h -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/gzlib.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/gzlib.c -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/gzread.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/gzread.c -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/gzwrite.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/gzwrite.c -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/infback.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/infback.c -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/inffast.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/inffast.c -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/inffast.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/inffast.h -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/inflate.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/inflate.c -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/inflate.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/inflate.h -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/trees.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/trees.c -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/trees.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/trees.h -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/uncompr.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/uncompr.c -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/zconf.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/zconf.h -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/zlib.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/zlib.h -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/zutil.c: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/zutil.c -------------------------------------------------------------------------------- /landmark/dlib/external/zlib/zutil.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/external/zlib/zutil.h -------------------------------------------------------------------------------- /landmark/dlib/filtering.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/filtering.h -------------------------------------------------------------------------------- /landmark/dlib/filtering/rls_filter.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/filtering/rls_filter.h -------------------------------------------------------------------------------- /landmark/dlib/float_details.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/float_details.h -------------------------------------------------------------------------------- /landmark/dlib/fstream: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/fstream -------------------------------------------------------------------------------- /landmark/dlib/general_hash/hash.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/general_hash/hash.h -------------------------------------------------------------------------------- /landmark/dlib/geometry.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/geometry.h -------------------------------------------------------------------------------- /landmark/dlib/geometry/drectangle.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/geometry/drectangle.h -------------------------------------------------------------------------------- /landmark/dlib/geometry/line.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/geometry/line.h -------------------------------------------------------------------------------- /landmark/dlib/geometry/rectangle.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/geometry/rectangle.h -------------------------------------------------------------------------------- /landmark/dlib/geometry/vector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/geometry/vector.h -------------------------------------------------------------------------------- /landmark/dlib/global_optimization.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/global_optimization.h -------------------------------------------------------------------------------- /landmark/dlib/graph.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/graph.h -------------------------------------------------------------------------------- /landmark/dlib/graph/graph_kernel_1.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/graph/graph_kernel_1.h -------------------------------------------------------------------------------- /landmark/dlib/graph_cuts.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/graph_cuts.h -------------------------------------------------------------------------------- /landmark/dlib/graph_cuts/min_cut.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/graph_cuts/min_cut.h -------------------------------------------------------------------------------- /landmark/dlib/graph_utils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/graph_utils.h -------------------------------------------------------------------------------- /landmark/dlib/graph_utils_threaded.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/graph_utils_threaded.h -------------------------------------------------------------------------------- /landmark/dlib/gui_core.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/gui_core.h -------------------------------------------------------------------------------- /landmark/dlib/gui_core/windows.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/gui_core/windows.h -------------------------------------------------------------------------------- /landmark/dlib/gui_core/xlib.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/gui_core/xlib.h -------------------------------------------------------------------------------- /landmark/dlib/gui_widgets.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/gui_widgets.h -------------------------------------------------------------------------------- /landmark/dlib/gui_widgets/drawable.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/gui_widgets/drawable.h -------------------------------------------------------------------------------- /landmark/dlib/gui_widgets/fonts.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/gui_widgets/fonts.cpp -------------------------------------------------------------------------------- /landmark/dlib/gui_widgets/fonts.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/gui_widgets/fonts.h -------------------------------------------------------------------------------- /landmark/dlib/gui_widgets/style.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/gui_widgets/style.cpp -------------------------------------------------------------------------------- /landmark/dlib/gui_widgets/style.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/gui_widgets/style.h -------------------------------------------------------------------------------- /landmark/dlib/gui_widgets/widgets.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/gui_widgets/widgets.cpp -------------------------------------------------------------------------------- /landmark/dlib/gui_widgets/widgets.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/gui_widgets/widgets.h -------------------------------------------------------------------------------- /landmark/dlib/hash.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/hash.h -------------------------------------------------------------------------------- /landmark/dlib/hash_map.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/hash_map.h -------------------------------------------------------------------------------- /landmark/dlib/hash_set.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/hash_set.h -------------------------------------------------------------------------------- /landmark/dlib/hash_table.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/hash_table.h -------------------------------------------------------------------------------- /landmark/dlib/image_io.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/image_io.h -------------------------------------------------------------------------------- /landmark/dlib/image_keypoint.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/image_keypoint.h -------------------------------------------------------------------------------- /landmark/dlib/image_keypoint/hog.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/image_keypoint/hog.h -------------------------------------------------------------------------------- /landmark/dlib/image_keypoint/surf.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/image_keypoint/surf.h -------------------------------------------------------------------------------- /landmark/dlib/image_processing.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/image_processing.h -------------------------------------------------------------------------------- /landmark/dlib/image_saver/save_jpeg.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/image_saver/save_jpeg.h -------------------------------------------------------------------------------- /landmark/dlib/image_saver/save_png.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/image_saver/save_png.h -------------------------------------------------------------------------------- /landmark/dlib/image_transforms.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/image_transforms.h -------------------------------------------------------------------------------- /landmark/dlib/image_transforms/draw.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/image_transforms/draw.h -------------------------------------------------------------------------------- /landmark/dlib/image_transforms/fhog.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/image_transforms/fhog.h -------------------------------------------------------------------------------- /landmark/dlib/image_transforms/lbp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/image_transforms/lbp.h -------------------------------------------------------------------------------- /landmark/dlib/interfaces/enumerable.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/interfaces/enumerable.h -------------------------------------------------------------------------------- /landmark/dlib/interfaces/map_pair.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/interfaces/map_pair.h -------------------------------------------------------------------------------- /landmark/dlib/interfaces/remover.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/interfaces/remover.h -------------------------------------------------------------------------------- /landmark/dlib/iomanip: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/iomanip -------------------------------------------------------------------------------- /landmark/dlib/iosfwd: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/iosfwd -------------------------------------------------------------------------------- /landmark/dlib/iosockstream.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/iosockstream.h -------------------------------------------------------------------------------- /landmark/dlib/iostream: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/iostream -------------------------------------------------------------------------------- /landmark/dlib/is_kind.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/is_kind.h -------------------------------------------------------------------------------- /landmark/dlib/istream: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/istream -------------------------------------------------------------------------------- /landmark/dlib/java/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/java/CMakeLists.txt -------------------------------------------------------------------------------- /landmark/dlib/java/cmake_swig_jni: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/java/cmake_swig_jni -------------------------------------------------------------------------------- /landmark/dlib/java/java_array.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/java/java_array.h -------------------------------------------------------------------------------- /landmark/dlib/java/run_test.sh: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/java/run_test.sh -------------------------------------------------------------------------------- /landmark/dlib/java/swig_api.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/java/swig_api.h -------------------------------------------------------------------------------- /landmark/dlib/java/swig_test.java: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/java/swig_test.java -------------------------------------------------------------------------------- /landmark/dlib/linker.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/linker.h -------------------------------------------------------------------------------- /landmark/dlib/locale: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/locale -------------------------------------------------------------------------------- /landmark/dlib/logger.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/logger.h -------------------------------------------------------------------------------- /landmark/dlib/lsh.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/lsh.h -------------------------------------------------------------------------------- /landmark/dlib/lsh/hashes.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/lsh/hashes.h -------------------------------------------------------------------------------- /landmark/dlib/lsh/hashes_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/lsh/hashes_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/lsh/projection_hash.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/lsh/projection_hash.h -------------------------------------------------------------------------------- /landmark/dlib/lz77_buffer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/lz77_buffer.h -------------------------------------------------------------------------------- /landmark/dlib/lzp_buffer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/lzp_buffer.h -------------------------------------------------------------------------------- /landmark/dlib/map.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/map.h -------------------------------------------------------------------------------- /landmark/dlib/map/map_kernel_1.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/map/map_kernel_1.h -------------------------------------------------------------------------------- /landmark/dlib/map/map_kernel_c.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/map/map_kernel_c.h -------------------------------------------------------------------------------- /landmark/dlib/matlab/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matlab/CMakeLists.txt -------------------------------------------------------------------------------- /landmark/dlib/matlab/README.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matlab/README.txt -------------------------------------------------------------------------------- /landmark/dlib/matlab/call_matlab.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matlab/call_matlab.h -------------------------------------------------------------------------------- /landmark/dlib/matlab/example.m: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matlab/example.m -------------------------------------------------------------------------------- /landmark/dlib/matlab/mex_wrapper.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matlab/mex_wrapper.cpp -------------------------------------------------------------------------------- /landmark/dlib/matrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/lapack/gees.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/lapack/gees.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/lapack/geev.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/lapack/geev.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/lapack/geqrf.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/lapack/geqrf.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/lapack/gesdd.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/lapack/gesdd.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/lapack/gesvd.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/lapack/gesvd.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/lapack/getrf.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/lapack/getrf.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/lapack/ormqr.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/lapack/ormqr.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/lapack/pbtrf.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/lapack/pbtrf.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/lapack/potrf.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/lapack/potrf.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/lapack/syev.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/lapack/syev.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/lapack/syevr.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/lapack/syevr.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/matrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/matrix.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/matrix_assign.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/matrix_assign.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/matrix_conv.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/matrix_conv.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/matrix_exp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/matrix_exp.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/matrix_fft.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/matrix_fft.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/matrix_fwd.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/matrix_fwd.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/matrix_la.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/matrix_la.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/matrix_lu.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/matrix_lu.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/matrix_mat.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/matrix_mat.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/matrix_op.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/matrix_op.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/matrix_qr.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/matrix_qr.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/matrix_subexp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/matrix_subexp.h -------------------------------------------------------------------------------- /landmark/dlib/matrix/matrix_trsm.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/matrix/matrix_trsm.h -------------------------------------------------------------------------------- /landmark/dlib/md5.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/md5.h -------------------------------------------------------------------------------- /landmark/dlib/md5/md5_kernel_1.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/md5/md5_kernel_1.cpp -------------------------------------------------------------------------------- /landmark/dlib/md5/md5_kernel_1.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/md5/md5_kernel_1.h -------------------------------------------------------------------------------- /landmark/dlib/memory_manager.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/memory_manager.h -------------------------------------------------------------------------------- /landmark/dlib/memory_manager_global.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/memory_manager_global.h -------------------------------------------------------------------------------- /landmark/dlib/metaprogramming.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/metaprogramming.h -------------------------------------------------------------------------------- /landmark/dlib/misc_api.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/misc_api.h -------------------------------------------------------------------------------- /landmark/dlib/misc_api/posix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/misc_api/posix.h -------------------------------------------------------------------------------- /landmark/dlib/misc_api/windows.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/misc_api/windows.h -------------------------------------------------------------------------------- /landmark/dlib/mlp.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/mlp.h -------------------------------------------------------------------------------- /landmark/dlib/mlp/mlp_kernel_1.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/mlp/mlp_kernel_1.h -------------------------------------------------------------------------------- /landmark/dlib/mlp/mlp_kernel_c.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/mlp/mlp_kernel_c.h -------------------------------------------------------------------------------- /landmark/dlib/noncopyable.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/noncopyable.h -------------------------------------------------------------------------------- /landmark/dlib/numeric_constants.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/numeric_constants.h -------------------------------------------------------------------------------- /landmark/dlib/numerical_integration.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/numerical_integration.h -------------------------------------------------------------------------------- /landmark/dlib/opencv.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/opencv.h -------------------------------------------------------------------------------- /landmark/dlib/opencv/cv_image.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/opencv/cv_image.h -------------------------------------------------------------------------------- /landmark/dlib/opencv/to_open_cv.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/opencv/to_open_cv.h -------------------------------------------------------------------------------- /landmark/dlib/optimization.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/optimization.h -------------------------------------------------------------------------------- /landmark/dlib/ostream: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/ostream -------------------------------------------------------------------------------- /landmark/dlib/pipe.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/pipe.h -------------------------------------------------------------------------------- /landmark/dlib/pipe/pipe_kernel_1.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/pipe/pipe_kernel_1.h -------------------------------------------------------------------------------- /landmark/dlib/pixel.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/pixel.h -------------------------------------------------------------------------------- /landmark/dlib/platform.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/platform.h -------------------------------------------------------------------------------- /landmark/dlib/python.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/python.h -------------------------------------------------------------------------------- /landmark/dlib/python/numpy_image.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/python/numpy_image.h -------------------------------------------------------------------------------- /landmark/dlib/python/pyassert.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/python/pyassert.h -------------------------------------------------------------------------------- /landmark/dlib/python/pybind_utils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/python/pybind_utils.h -------------------------------------------------------------------------------- /landmark/dlib/quantum_computing.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/quantum_computing.h -------------------------------------------------------------------------------- /landmark/dlib/queue.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/queue.h -------------------------------------------------------------------------------- /landmark/dlib/queue/queue_kernel_1.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/queue/queue_kernel_1.h -------------------------------------------------------------------------------- /landmark/dlib/queue/queue_kernel_2.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/queue/queue_kernel_2.h -------------------------------------------------------------------------------- /landmark/dlib/queue/queue_kernel_c.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/queue/queue_kernel_c.h -------------------------------------------------------------------------------- /landmark/dlib/queue/queue_sort_1.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/queue/queue_sort_1.h -------------------------------------------------------------------------------- /landmark/dlib/rand.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/rand.h -------------------------------------------------------------------------------- /landmark/dlib/rand/mersenne_twister.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/rand/mersenne_twister.h -------------------------------------------------------------------------------- /landmark/dlib/rand/rand_kernel_1.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/rand/rand_kernel_1.h -------------------------------------------------------------------------------- /landmark/dlib/random_forest.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/random_forest.h -------------------------------------------------------------------------------- /landmark/dlib/ref.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/ref.h -------------------------------------------------------------------------------- /landmark/dlib/reference_counter.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/reference_counter.h -------------------------------------------------------------------------------- /landmark/dlib/revision.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/revision.h -------------------------------------------------------------------------------- /landmark/dlib/revision.h.in: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/revision.h.in -------------------------------------------------------------------------------- /landmark/dlib/sequence.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/sequence.h -------------------------------------------------------------------------------- /landmark/dlib/serialize.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/serialize.h -------------------------------------------------------------------------------- /landmark/dlib/server.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/server.h -------------------------------------------------------------------------------- /landmark/dlib/server/server_http.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/server/server_http.cpp -------------------------------------------------------------------------------- /landmark/dlib/server/server_http.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/server/server_http.h -------------------------------------------------------------------------------- /landmark/dlib/server/server_kernel.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/server/server_kernel.h -------------------------------------------------------------------------------- /landmark/dlib/set.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/set.h -------------------------------------------------------------------------------- /landmark/dlib/set/set_compare_1.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/set/set_compare_1.h -------------------------------------------------------------------------------- /landmark/dlib/set/set_kernel_1.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/set/set_kernel_1.h -------------------------------------------------------------------------------- /landmark/dlib/set/set_kernel_c.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/set/set_kernel_c.h -------------------------------------------------------------------------------- /landmark/dlib/set_utils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/set_utils.h -------------------------------------------------------------------------------- /landmark/dlib/set_utils/set_utils.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/set_utils/set_utils.h -------------------------------------------------------------------------------- /landmark/dlib/simd.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/simd.h -------------------------------------------------------------------------------- /landmark/dlib/simd/simd4f.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/simd/simd4f.h -------------------------------------------------------------------------------- /landmark/dlib/simd/simd4i.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/simd/simd4i.h -------------------------------------------------------------------------------- /landmark/dlib/simd/simd8f.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/simd/simd8f.h -------------------------------------------------------------------------------- /landmark/dlib/simd/simd8i.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/simd/simd8i.h -------------------------------------------------------------------------------- /landmark/dlib/simd/simd_check.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/simd/simd_check.h -------------------------------------------------------------------------------- /landmark/dlib/sliding_buffer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/sliding_buffer.h -------------------------------------------------------------------------------- /landmark/dlib/smart_pointers.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/smart_pointers.h -------------------------------------------------------------------------------- /landmark/dlib/sockets.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/sockets.h -------------------------------------------------------------------------------- /landmark/dlib/sockets/posix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/sockets/posix.h -------------------------------------------------------------------------------- /landmark/dlib/sockets/windows.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/sockets/windows.h -------------------------------------------------------------------------------- /landmark/dlib/sockstreambuf.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/sockstreambuf.h -------------------------------------------------------------------------------- /landmark/dlib/sort.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/sort.h -------------------------------------------------------------------------------- /landmark/dlib/sparse_vector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/sparse_vector.h -------------------------------------------------------------------------------- /landmark/dlib/sqlite.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/sqlite.h -------------------------------------------------------------------------------- /landmark/dlib/sqlite/sqlite.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/sqlite/sqlite.h -------------------------------------------------------------------------------- /landmark/dlib/sqlite/sqlite_tools.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/sqlite/sqlite_tools.h -------------------------------------------------------------------------------- /landmark/dlib/sstream: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/sstream -------------------------------------------------------------------------------- /landmark/dlib/stack.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/stack.h -------------------------------------------------------------------------------- /landmark/dlib/stack/stack_kernel_1.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/stack/stack_kernel_1.h -------------------------------------------------------------------------------- /landmark/dlib/stack/stack_kernel_c.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/stack/stack_kernel_c.h -------------------------------------------------------------------------------- /landmark/dlib/stack_trace.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/stack_trace.cpp -------------------------------------------------------------------------------- /landmark/dlib/stack_trace.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/stack_trace.h -------------------------------------------------------------------------------- /landmark/dlib/static_map.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/static_map.h -------------------------------------------------------------------------------- /landmark/dlib/static_set.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/static_set.h -------------------------------------------------------------------------------- /landmark/dlib/statistics.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/statistics.h -------------------------------------------------------------------------------- /landmark/dlib/statistics/cca.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/statistics/cca.h -------------------------------------------------------------------------------- /landmark/dlib/statistics/dpca.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/statistics/dpca.h -------------------------------------------------------------------------------- /landmark/dlib/statistics/lda.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/statistics/lda.h -------------------------------------------------------------------------------- /landmark/dlib/statistics/sammon.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/statistics/sammon.h -------------------------------------------------------------------------------- /landmark/dlib/statistics/statistics.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/statistics/statistics.h -------------------------------------------------------------------------------- /landmark/dlib/std_allocator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/std_allocator.h -------------------------------------------------------------------------------- /landmark/dlib/stl_checked.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/stl_checked.h -------------------------------------------------------------------------------- /landmark/dlib/string.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/string.h -------------------------------------------------------------------------------- /landmark/dlib/string/cassert: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/string/cassert -------------------------------------------------------------------------------- /landmark/dlib/string/iomanip: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/string/iomanip -------------------------------------------------------------------------------- /landmark/dlib/string/iosfwd: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/string/iosfwd -------------------------------------------------------------------------------- /landmark/dlib/string/iostream: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/string/iostream -------------------------------------------------------------------------------- /landmark/dlib/string/locale: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/string/locale -------------------------------------------------------------------------------- /landmark/dlib/string/string.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/string/string.h -------------------------------------------------------------------------------- /landmark/dlib/svm.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm.h -------------------------------------------------------------------------------- /landmark/dlib/svm/active_learning.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/active_learning.h -------------------------------------------------------------------------------- /landmark/dlib/svm/auto.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/auto.cpp -------------------------------------------------------------------------------- /landmark/dlib/svm/auto.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/auto.h -------------------------------------------------------------------------------- /landmark/dlib/svm/auto_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/auto_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/svm/feature_ranking.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/feature_ranking.h -------------------------------------------------------------------------------- /landmark/dlib/svm/function.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/function.h -------------------------------------------------------------------------------- /landmark/dlib/svm/function_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/function_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/svm/kcentroid.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/kcentroid.h -------------------------------------------------------------------------------- /landmark/dlib/svm/kernel.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/kernel.h -------------------------------------------------------------------------------- /landmark/dlib/svm/kernel_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/kernel_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/svm/kernel_matrix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/kernel_matrix.h -------------------------------------------------------------------------------- /landmark/dlib/svm/kkmeans.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/kkmeans.h -------------------------------------------------------------------------------- /landmark/dlib/svm/kkmeans_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/kkmeans_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/svm/krls.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/krls.h -------------------------------------------------------------------------------- /landmark/dlib/svm/krls_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/krls_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/svm/krr_trainer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/krr_trainer.h -------------------------------------------------------------------------------- /landmark/dlib/svm/multiclass_tools.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/multiclass_tools.h -------------------------------------------------------------------------------- /landmark/dlib/svm/null_df.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/null_df.h -------------------------------------------------------------------------------- /landmark/dlib/svm/null_trainer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/null_trainer.h -------------------------------------------------------------------------------- /landmark/dlib/svm/pegasos.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/pegasos.h -------------------------------------------------------------------------------- /landmark/dlib/svm/pegasos_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/pegasos_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/svm/ranking_tools.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/ranking_tools.h -------------------------------------------------------------------------------- /landmark/dlib/svm/rbf_network.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/rbf_network.h -------------------------------------------------------------------------------- /landmark/dlib/svm/reduced.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/reduced.h -------------------------------------------------------------------------------- /landmark/dlib/svm/reduced_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/reduced_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/svm/rls.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/rls.h -------------------------------------------------------------------------------- /landmark/dlib/svm/rls_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/rls_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/svm/roc_trainer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/roc_trainer.h -------------------------------------------------------------------------------- /landmark/dlib/svm/rr_trainer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/rr_trainer.h -------------------------------------------------------------------------------- /landmark/dlib/svm/rvm.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/rvm.h -------------------------------------------------------------------------------- /landmark/dlib/svm/rvm_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/rvm_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/svm/sequence_labeler.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/sequence_labeler.h -------------------------------------------------------------------------------- /landmark/dlib/svm/sparse_kernel.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/sparse_kernel.h -------------------------------------------------------------------------------- /landmark/dlib/svm/sparse_vector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/sparse_vector.h -------------------------------------------------------------------------------- /landmark/dlib/svm/svm.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/svm.h -------------------------------------------------------------------------------- /landmark/dlib/svm/svm_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/svm_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/svm/svm_c_ekm_trainer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/svm_c_ekm_trainer.h -------------------------------------------------------------------------------- /landmark/dlib/svm/svm_c_trainer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/svm_c_trainer.h -------------------------------------------------------------------------------- /landmark/dlib/svm/svm_nu_trainer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/svm_nu_trainer.h -------------------------------------------------------------------------------- /landmark/dlib/svm/svm_rank_trainer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/svm_rank_trainer.h -------------------------------------------------------------------------------- /landmark/dlib/svm/svm_threaded.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/svm_threaded.h -------------------------------------------------------------------------------- /landmark/dlib/svm/svr_trainer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm/svr_trainer.h -------------------------------------------------------------------------------- /landmark/dlib/svm_threaded.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/svm_threaded.h -------------------------------------------------------------------------------- /landmark/dlib/sync_extension.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/sync_extension.h -------------------------------------------------------------------------------- /landmark/dlib/test/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/CMakeLists.txt -------------------------------------------------------------------------------- /landmark/dlib/test/any.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/any.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/any_function.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/any_function.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/array.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/array.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/array2d.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/array2d.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/base64.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/base64.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/bayes_nets.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/bayes_nets.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/bigint.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/bigint.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/bridge.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/bridge.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/bsp.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/bsp.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/byte_orderer.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/byte_orderer.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/cca.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/cca.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/checkerboard.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/checkerboard.h -------------------------------------------------------------------------------- /landmark/dlib/test/clustering.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/clustering.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/cmd_line_parser.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/cmd_line_parser.h -------------------------------------------------------------------------------- /landmark/dlib/test/config_reader.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/config_reader.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/crc32.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/crc32.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/cublas.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/cublas.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/data_io.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/data_io.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/directed_graph.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/directed_graph.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/dnn.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/dnn.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/ekm_and_lisf.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/ekm_and_lisf.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/elastic_net.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/elastic_net.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/entropy_coder.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/entropy_coder.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/example.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/example.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/example_args.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/example_args.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/face.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/face.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/fft.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/fft.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/fhog.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/fhog.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/filtering.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/filtering.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/geometry.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/geometry.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/graph.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/graph.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/graph_cuts.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/graph_cuts.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/graph_labeler.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/graph_labeler.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/gui/CMakeLists.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/gui/CMakeLists.txt -------------------------------------------------------------------------------- /landmark/dlib/test/gui/main.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/gui/main.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/hash.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/hash.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/hash_map.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/hash_map.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/hash_set.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/hash_set.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/hash_table.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/hash_table.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/hog_image.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/hog_image.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/image.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/image.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/iosockstream.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/iosockstream.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/is_same_object.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/is_same_object.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/kcentroid.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/kcentroid.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/kernel_matrix.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/kernel_matrix.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/kmeans.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/kmeans.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/least_squares.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/least_squares.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/lspi.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/lspi.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/lz77_buffer.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/lz77_buffer.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/main.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/main.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/makefile: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/makefile -------------------------------------------------------------------------------- /landmark/dlib/test/map.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/map.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/matrix.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/matrix.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/matrix2.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/matrix2.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/matrix3.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/matrix3.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/matrix4.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/matrix4.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/matrix_chol.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/matrix_chol.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/matrix_eig.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/matrix_eig.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/matrix_lu.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/matrix_lu.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/matrix_qr.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/matrix_qr.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/md5.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/md5.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/mpc.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/mpc.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/oca.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/oca.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/opt_qp_solver.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/opt_qp_solver.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/optimization.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/optimization.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/parallel_for.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/parallel_for.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/parse.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/parse.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/pipe.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/pipe.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/pixel.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/pixel.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/probabilistic.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/probabilistic.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/pyramid_down.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/pyramid_down.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/queue.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/queue.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/rand.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/rand.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/random_forest.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/random_forest.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/ranking.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/ranking.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/rls.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/rls.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/sammon.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/sammon.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/scan_image.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/scan_image.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/sequence.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/sequence.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/serialize.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/serialize.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/set.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/set.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/sldf.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/sldf.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/sliding_buffer.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/sliding_buffer.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/smart_pointers.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/smart_pointers.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/sockets.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/sockets.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/sockets2.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/sockets2.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/sockstreambuf.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/sockstreambuf.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/sparse_vector.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/sparse_vector.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/stack.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/stack.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/static_map.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/static_map.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/static_set.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/static_set.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/statistics.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/statistics.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/std_vector_c.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/std_vector_c.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/string.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/string.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/svm.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/svm.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/svm_c_linear.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/svm_c_linear.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/svm_struct.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/svm_struct.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/tester.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/tester.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/tester.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/tester.h -------------------------------------------------------------------------------- /landmark/dlib/test/thread_pool.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/thread_pool.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/threads.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/threads.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/timer.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/timer.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/tokenizer.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/tokenizer.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/trust_region.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/trust_region.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/tuple.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/tuple.cpp -------------------------------------------------------------------------------- /landmark/dlib/test/vectorstream.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/test/vectorstream.cpp -------------------------------------------------------------------------------- /landmark/dlib/threads.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/threads.h -------------------------------------------------------------------------------- /landmark/dlib/threads/async.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/threads/async.cpp -------------------------------------------------------------------------------- /landmark/dlib/threads/async.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/threads/async.h -------------------------------------------------------------------------------- /landmark/dlib/threads/posix.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/threads/posix.h -------------------------------------------------------------------------------- /landmark/dlib/threads/windows.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/threads/windows.h -------------------------------------------------------------------------------- /landmark/dlib/time_this.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/time_this.h -------------------------------------------------------------------------------- /landmark/dlib/timeout.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/timeout.h -------------------------------------------------------------------------------- /landmark/dlib/timeout/timeout.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/timeout/timeout.h -------------------------------------------------------------------------------- /landmark/dlib/timer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/timer.h -------------------------------------------------------------------------------- /landmark/dlib/timer/timer.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/timer/timer.cpp -------------------------------------------------------------------------------- /landmark/dlib/timer/timer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/timer/timer.h -------------------------------------------------------------------------------- /landmark/dlib/timer/timer_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/timer/timer_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/timer/timer_heavy.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/timer/timer_heavy.h -------------------------------------------------------------------------------- /landmark/dlib/timing.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/timing.h -------------------------------------------------------------------------------- /landmark/dlib/tokenizer.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/tokenizer.h -------------------------------------------------------------------------------- /landmark/dlib/tuple.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/tuple.h -------------------------------------------------------------------------------- /landmark/dlib/tuple/tuple.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/tuple/tuple.h -------------------------------------------------------------------------------- /landmark/dlib/tuple/tuple_abstract.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/tuple/tuple_abstract.h -------------------------------------------------------------------------------- /landmark/dlib/type_safe_union.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/type_safe_union.h -------------------------------------------------------------------------------- /landmark/dlib/uintn.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/uintn.h -------------------------------------------------------------------------------- /landmark/dlib/unicode.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/unicode.h -------------------------------------------------------------------------------- /landmark/dlib/unicode/unicode.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/unicode/unicode.cpp -------------------------------------------------------------------------------- /landmark/dlib/unicode/unicode.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/unicode/unicode.h -------------------------------------------------------------------------------- /landmark/dlib/unordered_pair.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/unordered_pair.h -------------------------------------------------------------------------------- /landmark/dlib/vectorstream.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/vectorstream.h -------------------------------------------------------------------------------- /landmark/dlib/windows_magic.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/windows_magic.h -------------------------------------------------------------------------------- /landmark/dlib/xml_parser.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/dlib/xml_parser.h -------------------------------------------------------------------------------- /landmark/landmark_detection.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/landmark_detection.cpp -------------------------------------------------------------------------------- /landmark/landmark_detection.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/landmark_detection.h -------------------------------------------------------------------------------- /landmark/stdafx.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/stdafx.cpp -------------------------------------------------------------------------------- /landmark/stdafx.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/stdafx.h -------------------------------------------------------------------------------- /landmark/tbb/aggregator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/aggregator.h -------------------------------------------------------------------------------- /landmark/tbb/aligned_space.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/aligned_space.h -------------------------------------------------------------------------------- /landmark/tbb/atomic.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/atomic.h -------------------------------------------------------------------------------- /landmark/tbb/blocked_range.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/blocked_range.h -------------------------------------------------------------------------------- /landmark/tbb/blocked_range2d.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/blocked_range2d.h -------------------------------------------------------------------------------- /landmark/tbb/blocked_range3d.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/blocked_range3d.h -------------------------------------------------------------------------------- /landmark/tbb/combinable.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/combinable.h -------------------------------------------------------------------------------- /landmark/tbb/compat/ppl.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/compat/ppl.h -------------------------------------------------------------------------------- /landmark/tbb/compat/thread: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/compat/thread -------------------------------------------------------------------------------- /landmark/tbb/compat/tuple: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/compat/tuple -------------------------------------------------------------------------------- /landmark/tbb/concurrent_hash_map.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/concurrent_hash_map.h -------------------------------------------------------------------------------- /landmark/tbb/concurrent_lru_cache.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/concurrent_lru_cache.h -------------------------------------------------------------------------------- /landmark/tbb/concurrent_queue.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/concurrent_queue.h -------------------------------------------------------------------------------- /landmark/tbb/concurrent_vector.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/concurrent_vector.h -------------------------------------------------------------------------------- /landmark/tbb/critical_section.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/critical_section.h -------------------------------------------------------------------------------- /landmark/tbb/flow_graph.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/flow_graph.h -------------------------------------------------------------------------------- /landmark/tbb/gfx_factory.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/gfx_factory.h -------------------------------------------------------------------------------- /landmark/tbb/global_control.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/global_control.h -------------------------------------------------------------------------------- /landmark/tbb/index.html: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/index.html -------------------------------------------------------------------------------- /landmark/tbb/machine/gcc_armv7.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/machine/gcc_armv7.h -------------------------------------------------------------------------------- /landmark/tbb/machine/gcc_generic.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/machine/gcc_generic.h -------------------------------------------------------------------------------- /landmark/tbb/machine/gcc_itsx.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/machine/gcc_itsx.h -------------------------------------------------------------------------------- /landmark/tbb/machine/ibm_aix51.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/machine/ibm_aix51.h -------------------------------------------------------------------------------- /landmark/tbb/machine/icc_generic.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/machine/icc_generic.h -------------------------------------------------------------------------------- /landmark/tbb/machine/linux_ia32.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/machine/linux_ia32.h -------------------------------------------------------------------------------- /landmark/tbb/machine/linux_ia64.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/machine/linux_ia64.h -------------------------------------------------------------------------------- /landmark/tbb/machine/mac_ppc.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/machine/mac_ppc.h -------------------------------------------------------------------------------- /landmark/tbb/machine/mic_common.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/machine/mic_common.h -------------------------------------------------------------------------------- /landmark/tbb/machine/msvc_armv7.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/machine/msvc_armv7.h -------------------------------------------------------------------------------- /landmark/tbb/machine/sunos_sparc.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/machine/sunos_sparc.h -------------------------------------------------------------------------------- /landmark/tbb/machine/windows_api.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/machine/windows_api.h -------------------------------------------------------------------------------- /landmark/tbb/memory_pool.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/memory_pool.h -------------------------------------------------------------------------------- /landmark/tbb/mutex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/mutex.h -------------------------------------------------------------------------------- /landmark/tbb/null_mutex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/null_mutex.h -------------------------------------------------------------------------------- /landmark/tbb/null_rw_mutex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/null_rw_mutex.h -------------------------------------------------------------------------------- /landmark/tbb/parallel_do.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/parallel_do.h -------------------------------------------------------------------------------- /landmark/tbb/parallel_for.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/parallel_for.h -------------------------------------------------------------------------------- /landmark/tbb/parallel_for_each.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/parallel_for_each.h -------------------------------------------------------------------------------- /landmark/tbb/parallel_invoke.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/parallel_invoke.h -------------------------------------------------------------------------------- /landmark/tbb/parallel_reduce.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/parallel_reduce.h -------------------------------------------------------------------------------- /landmark/tbb/parallel_scan.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/parallel_scan.h -------------------------------------------------------------------------------- /landmark/tbb/parallel_sort.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/parallel_sort.h -------------------------------------------------------------------------------- /landmark/tbb/parallel_while.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/parallel_while.h -------------------------------------------------------------------------------- /landmark/tbb/partitioner.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/partitioner.h -------------------------------------------------------------------------------- /landmark/tbb/pipeline.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/pipeline.h -------------------------------------------------------------------------------- /landmark/tbb/queuing_mutex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/queuing_mutex.h -------------------------------------------------------------------------------- /landmark/tbb/queuing_rw_mutex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/queuing_rw_mutex.h -------------------------------------------------------------------------------- /landmark/tbb/reader_writer_lock.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/reader_writer_lock.h -------------------------------------------------------------------------------- /landmark/tbb/recursive_mutex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/recursive_mutex.h -------------------------------------------------------------------------------- /landmark/tbb/runtime_loader.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/runtime_loader.h -------------------------------------------------------------------------------- /landmark/tbb/scalable_allocator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/scalable_allocator.h -------------------------------------------------------------------------------- /landmark/tbb/spin_mutex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/spin_mutex.h -------------------------------------------------------------------------------- /landmark/tbb/spin_rw_mutex.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/spin_rw_mutex.h -------------------------------------------------------------------------------- /landmark/tbb/task.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/task.h -------------------------------------------------------------------------------- /landmark/tbb/task_arena.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/task_arena.h -------------------------------------------------------------------------------- /landmark/tbb/task_group.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/task_group.h -------------------------------------------------------------------------------- /landmark/tbb/task_scheduler_init.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/task_scheduler_init.h -------------------------------------------------------------------------------- /landmark/tbb/tbb.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/tbb.h -------------------------------------------------------------------------------- /landmark/tbb/tbb_allocator.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/tbb_allocator.h -------------------------------------------------------------------------------- /landmark/tbb/tbb_config.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/tbb_config.h -------------------------------------------------------------------------------- /landmark/tbb/tbb_exception.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/tbb_exception.h -------------------------------------------------------------------------------- /landmark/tbb/tbb_machine.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/tbb_machine.h -------------------------------------------------------------------------------- /landmark/tbb/tbb_profiling.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/tbb_profiling.h -------------------------------------------------------------------------------- /landmark/tbb/tbb_stddef.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/tbb_stddef.h -------------------------------------------------------------------------------- /landmark/tbb/tbb_thread.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/tbb_thread.h -------------------------------------------------------------------------------- /landmark/tbb/tbbmalloc_proxy.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/tbbmalloc_proxy.h -------------------------------------------------------------------------------- /landmark/tbb/tick_count.h: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/landmark/tbb/tick_count.h -------------------------------------------------------------------------------- /lib/dlib.lib: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/lib/dlib.lib -------------------------------------------------------------------------------- /lib/tbb.lib: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/lib/tbb.lib -------------------------------------------------------------------------------- /readme.md: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/readme.md -------------------------------------------------------------------------------- /res/albedo_high.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/albedo_high.bmp -------------------------------------------------------------------------------- /res/albedo_low.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/albedo_low.bmp -------------------------------------------------------------------------------- /res/geo_params.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/geo_params.txt -------------------------------------------------------------------------------- /res/prog/0.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/0.bmp -------------------------------------------------------------------------------- /res/prog/1.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/1.bmp -------------------------------------------------------------------------------- /res/prog/10.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/10.bmp -------------------------------------------------------------------------------- /res/prog/11.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/11.bmp -------------------------------------------------------------------------------- /res/prog/12.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/12.bmp -------------------------------------------------------------------------------- /res/prog/13.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/13.bmp -------------------------------------------------------------------------------- /res/prog/14.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/14.bmp -------------------------------------------------------------------------------- /res/prog/15.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/15.bmp -------------------------------------------------------------------------------- /res/prog/16.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/16.bmp -------------------------------------------------------------------------------- /res/prog/17.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/17.bmp -------------------------------------------------------------------------------- /res/prog/18.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/18.bmp -------------------------------------------------------------------------------- /res/prog/19.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/19.bmp -------------------------------------------------------------------------------- /res/prog/2.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/2.bmp -------------------------------------------------------------------------------- /res/prog/20.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/20.bmp -------------------------------------------------------------------------------- /res/prog/3.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/3.bmp -------------------------------------------------------------------------------- /res/prog/4.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/4.bmp -------------------------------------------------------------------------------- /res/prog/5.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/5.bmp -------------------------------------------------------------------------------- /res/prog/6.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/6.bmp -------------------------------------------------------------------------------- /res/prog/7.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/7.bmp -------------------------------------------------------------------------------- /res/prog/8.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/8.bmp -------------------------------------------------------------------------------- /res/prog/9.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/9.bmp -------------------------------------------------------------------------------- /res/prog/out.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/prog/out.gif -------------------------------------------------------------------------------- /res/reconstruct.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/reconstruct.bmp -------------------------------------------------------------------------------- /res/relit/out.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/out.gif -------------------------------------------------------------------------------- /res/relit/relight_hdr_0.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_0.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_1.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_1.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_10.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_10.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_11.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_11.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_12.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_12.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_13.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_13.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_14.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_14.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_15.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_15.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_16.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_16.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_17.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_17.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_18.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_18.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_19.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_19.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_2.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_2.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_20.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_20.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_3.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_3.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_4.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_4.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_5.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_5.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_6.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_6.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_7.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_7.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_8.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_8.bmp -------------------------------------------------------------------------------- /res/relit/relight_hdr_9.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/relit/relight_hdr_9.bmp -------------------------------------------------------------------------------- /res/render_params.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res/render_params.txt -------------------------------------------------------------------------------- /res2/albedo_high.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/albedo_high.bmp -------------------------------------------------------------------------------- /res2/albedo_low.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/albedo_low.bmp -------------------------------------------------------------------------------- /res2/geo_params.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/geo_params.txt -------------------------------------------------------------------------------- /res2/prog/0.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/0.bmp -------------------------------------------------------------------------------- /res2/prog/1.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/1.bmp -------------------------------------------------------------------------------- /res2/prog/10.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/10.bmp -------------------------------------------------------------------------------- /res2/prog/11.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/11.bmp -------------------------------------------------------------------------------- /res2/prog/12.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/12.bmp -------------------------------------------------------------------------------- /res2/prog/13.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/13.bmp -------------------------------------------------------------------------------- /res2/prog/14.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/14.bmp -------------------------------------------------------------------------------- /res2/prog/15.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/15.bmp -------------------------------------------------------------------------------- /res2/prog/16.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/16.bmp -------------------------------------------------------------------------------- /res2/prog/17.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/17.bmp -------------------------------------------------------------------------------- /res2/prog/18.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/18.bmp -------------------------------------------------------------------------------- /res2/prog/19.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/19.bmp -------------------------------------------------------------------------------- /res2/prog/2.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/2.bmp -------------------------------------------------------------------------------- /res2/prog/20.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/20.bmp -------------------------------------------------------------------------------- /res2/prog/3.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/3.bmp -------------------------------------------------------------------------------- /res2/prog/4.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/4.bmp -------------------------------------------------------------------------------- /res2/prog/5.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/5.bmp -------------------------------------------------------------------------------- /res2/prog/6.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/6.bmp -------------------------------------------------------------------------------- /res2/prog/7.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/7.bmp -------------------------------------------------------------------------------- /res2/prog/8.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/8.bmp -------------------------------------------------------------------------------- /res2/prog/9.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/9.bmp -------------------------------------------------------------------------------- /res2/prog/out.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/prog/out.gif -------------------------------------------------------------------------------- /res2/reconstruct.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/reconstruct.bmp -------------------------------------------------------------------------------- /res2/relit/out.gif: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/out.gif -------------------------------------------------------------------------------- /res2/relit/relight_hdr_0.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_0.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_1.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_1.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_10.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_10.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_11.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_11.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_12.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_12.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_13.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_13.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_14.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_14.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_15.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_15.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_16.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_16.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_17.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_17.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_18.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_18.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_19.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_19.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_2.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_2.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_20.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_20.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_3.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_3.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_4.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_4.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_5.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_5.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_6.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_6.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_7.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_7.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_8.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_8.bmp -------------------------------------------------------------------------------- /res2/relit/relight_hdr_9.bmp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/relit/relight_hdr_9.bmp -------------------------------------------------------------------------------- /res2/render_params.txt: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/res2/render_params.txt -------------------------------------------------------------------------------- /src/main.cpp: -------------------------------------------------------------------------------- https://raw.githubusercontent.com/gao-duan/FaceRelighting/HEAD/src/main.cpp --------------------------------------------------------------------------------