public void CalculateOriginalConstitutiveMatrixWithoutNLAnalysis() { ISolver solver; if (matrices_not_initialized) { this.InitializeMatrices(); this.InitializeData(); solver = createSolver(model); solver.OrderDofs(false); foreach (ILinearSystem linearSystem in solver.LinearSystems.Values) { linearSystem.Reset(); //TODO find out if new structures cause any problems linearSystem.Subdomain.Forces = Vector.CreateZero(linearSystem.Size); } this.InitializeFreeAndPrescribedDofsInitialDisplacementVectors(); } else { solver = createSolver(model); solver.OrderDofs(false); //v2.1. TODO: Is this needed in this case? foreach (ILinearSystem linearSystem in solver.LinearSystems.Values) { linearSystem.Reset(); } //solver.ResetSubdomainForcesVector(); } var elementProvider = new ElementStructuralStiffnessProvider(); #region INTEGRATION constitutive Matrix var integrationSimultaneous = new SubdomainCalculationsAndAssembly(); (Dictionary <int, double[][]> KfpDqSubdomains, Dictionary <int, double[][]> KppDqVectorsSubdomains) = integrationSimultaneous.UpdateSubdomainKffAndCalculateKfpDqAndKppDqpMultipleObje(model, elementProvider, scaleTransitions, boundaryNodes, boundaryElements, solver); Dictionary <int, double[][]> f2_vectorsSubdomains = SubdomainCalculationsMultiple.CalculateKffinverseKfpDqSubdomains(KfpDqSubdomains, model, elementProvider, scaleTransitions, boundaryNodes, solver); Dictionary <int, double[][]> f3_vectorsSubdomains = SubdomainCalculationsMultiple.CalculateKpfKffinverseKfpDqSubdomains(f2_vectorsSubdomains, model, elementProvider, scaleTransitions, boundaryNodes); double[][] f3_vectors = SubdomainCalculationsMultiple.CombineMultipleSubdomainsIntegrationVectorsIntoTotal(f3_vectorsSubdomains, scaleTransitions); double[][] KppDqVectors = SubdomainCalculationsMultiple.CombineMultipleSubdomainsIntegrationVectorsIntoTotal(KppDqVectorsSubdomains, scaleTransitions); double[][] f4_vectors = SubdomainCalculations.SubtractConsecutiveVectors(KppDqVectors, f3_vectors); double[,] DqCondDq = SubdomainCalculations.CalculateDqCondDq(f4_vectors, scaleTransitions, boundaryNodes); double[,] d2W_dfdf = new double[DqCondDq.GetLength(0), DqCondDq.GetLength(1)]; for (int i1 = 0; i1 < DqCondDq.GetLength(0); i1++) { for (int i2 = 0; i2 < DqCondDq.GetLength(1); i2++) { d2W_dfdf[i1, i2] = (1 / volume) * DqCondDq[i1, i2]; } } #endregion #region constitutive tensors transformation methods double[,] d2W_dFtrdFtr = Reorder_d2Wdfdf_to_d2W_dFtrdFtr(d2W_dfdf); double[,] SPK_mat = new double[3, 3] { { 0, 0, 0 }, { 0, 0, 0 }, { 0, 0, 0 } }; double[,] DefGradMat = new double[3, 3] { { 1, 0, 0 }, { 0, 1, 0 }, { 0, 0, 1 } }; double[,] Cinpk = Transform_d2WdFtrdFtr_to_Cijrs(d2W_dFtrdFtr, SPK_mat, DefGradMat); // to onomazoume Cinpk epeidh einai to 9x9 kai to diakrinoume etsi apo to Cijrs 6x6 double[,] Cijrs = CombineCinpkTensorTermsIntoMatrix(Cinpk); constitutiveMatrix = Matrix.CreateFromArray(Cijrs); #endregion //PrintMethodsForDebug(KfpDq, f2_vectors, f3_vectors, KppDqVectors, f4_vectors, DqCondDq, d2W_dfdf, Cijrs); this.modified = CheckIfConstitutiveMatrixChanged(); if (EstimateOnlyLinearResponse) { model = null; boundaryElements = null; boundaryNodes = null; rveBuilder = null; uInitialFreeDOFDisplacementsPerSubdomain = null; initialConvergedBoundaryDisplacements = null; Cijrs_prev = null; } }
public void UpdateMaterial(double[] smallStrainVec) { ISolver solver; if (matrices_not_initialized) { this.InitializeMatrices(); this.InitializeData(); solver = createSolver(model); solver.OrderDofs(false); foreach (ILinearSystem linearSystem in solver.LinearSystems.Values) { linearSystem.Reset(); //TODO find out if new structures cause any problems linearSystem.Subdomain.Forces = Vector.CreateZero(linearSystem.Size); } this.InitializeFreeAndPrescribedDofsInitialDisplacementVectors(); } else { solver = createSolver(model); solver.OrderDofs(false); //v2.1. TODO: Is this needed in this case? foreach (ILinearSystem linearSystem in solver.LinearSystems.Values) { linearSystem.Reset(); linearSystem.RhsVector = linearSystem.Subdomain.Forces; //TODO MS } } for (int i1 = 0; i1 < 6; i1++) { for (int j1 = 0; j1 < 6; j1++) { Cijrs_prev[i1, j1] = constitutiveMatrix[i1, j1]; } } #region Rve prescribed Dofs total DIsplacement Dictionary Creation (nessesary for NRNLAnalyzer) // epivolh metakinhsewn ston analyzer pou molis dhmiourghsame --> tha ginetai sto dictionary Dictionary <int, Dictionary <IDofType, double> > totalPrescribedBoundaryDisplacements = new Dictionary <int, Dictionary <IDofType, double> >(); foreach (Node boundaryNode in boundaryNodes.Values) { scaleTransitions.ModifyMicrostructureTotalPrescribedBoundaryDisplacementsVectorForMacroStrainVariable(boundaryNode, smallStrainVec, totalPrescribedBoundaryDisplacements); } #endregion //var linearSystems = CreateNecessaryLinearSystems(model); // OPOU pairnei rhs apo subdomainForces //var solver = GetAppropriateSolver(linearSystems); #region Creation of nessesary analyzers for NRNLAnalyzer and Creation of Microstructure analyzer (NRNLdevelop temporarilly) and solution ; int increments = 1; int MaxIterations = 100; int IterationsForMatrixRebuild = 1; (MicrostructureBvpNRNLAnalyzer microAnalyzer, ProblemStructural provider, ElementStructuralStiffnessProvider elementProvider) = AnalyzeMicrostructure(model, solver, increments, MaxIterations, IterationsForMatrixRebuild, totalPrescribedBoundaryDisplacements, initialConvergedBoundaryDisplacements, boundaryNodes, uInitialFreeDOFDisplacementsPerSubdomain); #endregion #region update of free converged displacements vectors uInitialFreeDOFDisplacementsPerSubdomain = microAnalyzer.GetConvergedSolutionVectorsOfFreeDofs();// ousiastika to u pou twra taftizetai me to uPlusuu #endregion #region INTEGRATION stresses Dictionary <int, IVector> du = microAnalyzer.GetConvergedIncrementalSolutionVectorsOfFreeDofs(); Dictionary <int, double[]> FppReactionVectorSubdomains = SubdomainCalculationsMultiple.CalculateFppReactionsVectorSubdomains(model, elementProvider, scaleTransitions, boundaryNodes, uInitialFreeDOFDisplacementsPerSubdomain, du, initialConvergedBoundaryDisplacements, totalPrescribedBoundaryDisplacements, increments, increments); double[] FppReactionVector = SubdomainCalculationsMultiple.CombineMultipleSubdomainsStressesIntegrationVectorsIntoTotal(FppReactionVectorSubdomains); double[] DqFpp = SubdomainCalculations.CalculateDqFpp(FppReactionVector, scaleTransitions, boundaryNodes); trueStressVec = new double [DqFpp.Length]; for (int i1 = 0; i1 < DqFpp.Length; i1++) { trueStressVec[i1] = (1 / volume) * DqFpp[i1]; } #endregion #region INTEGRATION constitutive Matrix var integrationSimultaneous = new SubdomainCalculationsAndAssembly(); (Dictionary <int, double[][]> KfpDqSubdomains, Dictionary <int, double[][]> KppDqVectorsSubdomains) = integrationSimultaneous.UpdateSubdomainKffAndCalculateKfpDqAndKppDqpMultipleObje(model, elementProvider, scaleTransitions, boundaryNodes, boundaryElements, solver); Dictionary <int, double[][]> f2_vectorsSubdomains = SubdomainCalculationsMultiple.CalculateKffinverseKfpDqSubdomains(KfpDqSubdomains, model, elementProvider, scaleTransitions, boundaryNodes, solver); Dictionary <int, double[][]> f3_vectorsSubdomains = SubdomainCalculationsMultiple.CalculateKpfKffinverseKfpDqSubdomains(f2_vectorsSubdomains, model, elementProvider, scaleTransitions, boundaryNodes); double[][] f3_vectors = SubdomainCalculationsMultiple.CombineMultipleSubdomainsIntegrationVectorsIntoTotal(f3_vectorsSubdomains, scaleTransitions); double[][] KppDqVectors = SubdomainCalculationsMultiple.CombineMultipleSubdomainsIntegrationVectorsIntoTotal(KppDqVectorsSubdomains, scaleTransitions); double[][] f4_vectors = SubdomainCalculations.SubtractConsecutiveVectors(KppDqVectors, f3_vectors); double[,] DqCondDq = SubdomainCalculations.CalculateDqCondDq(f4_vectors, scaleTransitions, boundaryNodes); double[,] constitutiveMat = new double[DqCondDq.GetLength(0), DqCondDq.GetLength(1)]; for (int i1 = 0; i1 < DqCondDq.GetLength(0); i1++) { for (int i2 = 0; i2 < DqCondDq.GetLength(1); i2++) { constitutiveMat[i1, i2] = (1 / volume) * DqCondDq[i1, i2]; } } #endregion #region update of prescribed converged displacements vectors; initialConvergedBoundaryDisplacements = totalPrescribedBoundaryDisplacements; #endregion #region constitutive tensors transformation methods #endregion this.constitutiveMatrix = Matrix.CreateFromArray(constitutiveMat); //PrintMethodsForDebug(KfpDq, f2_vectors, f3_vectors, KppDqVectors, f4_vectors, DqCondDq, d2W_dfdf, Cijrs); this.modified = CheckIfConstitutiveMatrixChanged(); }
public void UpdateMaterial(double[] DefGradVec) { ISolver solver; if (matrices_not_initialized) { this.InitializeMatrices(); this.InitializeData(); solver = createSolver(model); solver.OrderDofs(false); foreach (ILinearSystem linearSystem in solver.LinearSystems.Values) { linearSystem.Reset(); //TODO find out if new structures cause any problems linearSystem.Subdomain.Forces = Vector.CreateZero(linearSystem.Size); } this.InitializeFreeAndPrescribedDofsInitialDisplacementVectors(); } else { solver = createSolver(model); solver.OrderDofs(false); //v2.1. TODO: Is this needed in this case? foreach (ILinearSystem linearSystem in solver.LinearSystems.Values) { linearSystem.Reset(); linearSystem.RhsVector = linearSystem.Subdomain.Forces; //TODO MS } } for (int i1 = 0; i1 < 6; i1++) { for (int j1 = 0; j1 < 6; j1++) { Cijrs_prev[i1, j1] = constitutiveMatrix[i1, j1]; } } #region Rve prescribed Dofs total DIsplacement Dictionary Creation (nessesary for NRNLAnalyzer) Dictionary <int, Dictionary <IDofType, double> > totalPrescribedBoundaryDisplacements = new Dictionary <int, Dictionary <IDofType, double> >(); foreach (Node boundaryNode in boundaryNodes.Values) { scaleTransitions.ModifyMicrostructureTotalPrescribedBoundaryDisplacementsVectorForMacroStrainVariable(boundaryNode, DefGradVec, totalPrescribedBoundaryDisplacements); } #endregion //var linearSystems = CreateNecessaryLinearSystems(model); // OPOU pairnei rhs apo subdomainForces //var solver = GetAppropriateSolver(linearSystems); #region Creation of nessesary analyzers for NRNLAnalyzer and Creation of Microstructure analyzer (NRNLdevelop temporarilly) and solution ; int increments = 1; int MaxIterations = 100; int IterationsForMatrixRebuild = 1; (MicrostructureBvpNRNLAnalyzer microAnalyzer, ProblemStructural provider, ElementStructuralStiffnessProvider elementProvider) = AnalyzeMicrostructure(model, solver, increments, MaxIterations, IterationsForMatrixRebuild, totalPrescribedBoundaryDisplacements, initialConvergedBoundaryDisplacements, boundaryNodes, uInitialFreeDOFDisplacementsPerSubdomain); #endregion #region update of free converged displacements vectors uInitialFreeDOFDisplacementsPerSubdomain = microAnalyzer.GetConvergedSolutionVectorsOfFreeDofs();// ousiastika to u pou twra taftizetai me to uPlusuu #endregion #region INTEGRATION stresses Dictionary <int, IVector> du = microAnalyzer.GetConvergedIncrementalSolutionVectorsOfFreeDofs(); Dictionary <int, double[]> FppReactionVectorSubdomains = SubdomainCalculationsMultiple.CalculateFppReactionsVectorSubdomains(model, elementProvider, scaleTransitions, boundaryNodes, uInitialFreeDOFDisplacementsPerSubdomain, du, initialConvergedBoundaryDisplacements, totalPrescribedBoundaryDisplacements, increments, increments); double[] FppReactionVector = SubdomainCalculationsMultiple.CombineMultipleSubdomainsStressesIntegrationVectorsIntoTotal(FppReactionVectorSubdomains); double[] DqFpp = SubdomainCalculations.CalculateDqFpp(FppReactionVector, scaleTransitions, boundaryNodes); double[] FPK_vec = new double [DqFpp.Length]; for (int i1 = 0; i1 < DqFpp.Length; i1++) { FPK_vec[i1] = (1 / volume) * DqFpp[i1]; } double[,] DefGradMat = new double[3, 3] { { DefGradVec[0], DefGradVec[3], DefGradVec[6] }, { DefGradVec[7], DefGradVec[1], DefGradVec[4] }, { DefGradVec[5], DefGradVec[8], DefGradVec[2] } }; double[,] FPK_mat = new double[3, 3] { { FPK_vec[0], FPK_vec[3], FPK_vec[6] }, { FPK_vec[7], FPK_vec[1], FPK_vec[4] }, { FPK_vec[5], FPK_vec[8], FPK_vec[2] } }; double[,] SPK_mat = transformFPKtoSPK(DefGradMat, FPK_mat); SPK_vec = new double[6] { SPK_mat[0, 0], SPK_mat[1, 1], SPK_mat[2, 2], SPK_mat[0, 1], SPK_mat[1, 2], SPK_mat[0, 2] }; //TODOna elegxthei h parapanw anadiataxh kai o pollaplasiasmos #endregion #region INTEGRATION constitutive Matrix var integrationSimultaneous = new SubdomainCalculationsAndAssembly(); (Dictionary <int, double[][]> KfpDqSubdomains, Dictionary <int, double[][]> KppDqVectorsSubdomains) = integrationSimultaneous.UpdateSubdomainKffAndCalculateKfpDqAndKppDqpMultipleObje(model, elementProvider, scaleTransitions, boundaryNodes, boundaryElements, solver); Dictionary <int, double[][]> f2_vectorsSubdomains = SubdomainCalculationsMultiple.CalculateKffinverseKfpDqSubdomains(KfpDqSubdomains, model, elementProvider, scaleTransitions, boundaryNodes, solver); Dictionary <int, double[][]> f3_vectorsSubdomains = SubdomainCalculationsMultiple.CalculateKpfKffinverseKfpDqSubdomains(f2_vectorsSubdomains, model, elementProvider, scaleTransitions, boundaryNodes); double[][] f3_vectors = SubdomainCalculationsMultiple.CombineMultipleSubdomainsIntegrationVectorsIntoTotal(f3_vectorsSubdomains, scaleTransitions); double[][] KppDqVectors = SubdomainCalculationsMultiple.CombineMultipleSubdomainsIntegrationVectorsIntoTotal(KppDqVectorsSubdomains, scaleTransitions); double[][] f4_vectors = SubdomainCalculations.SubtractConsecutiveVectors(KppDqVectors, f3_vectors); double[,] DqCondDq = SubdomainCalculations.CalculateDqCondDq(f4_vectors, scaleTransitions, boundaryNodes); double[,] d2W_dfdf = new double[DqCondDq.GetLength(0), DqCondDq.GetLength(1)]; for (int i1 = 0; i1 < DqCondDq.GetLength(0); i1++) { for (int i2 = 0; i2 < DqCondDq.GetLength(1); i2++) { d2W_dfdf[i1, i2] = (1 / volume) * DqCondDq[i1, i2]; } } #endregion #region update of prescribed converged displacements vectors; initialConvergedBoundaryDisplacements = totalPrescribedBoundaryDisplacements; #endregion #region constitutive tensors transformation methods double[,] d2W_dFtrdFtr = Reorder_d2Wdfdf_to_d2W_dFtrdFtr(d2W_dfdf); double[,] Cinpk = Transform_d2WdFtrdFtr_to_Cijrs(d2W_dFtrdFtr, SPK_mat, DefGradMat); // to onomazoume Cinpk epeidh einai to 9x9 kai to diakrinoume etsi apo to Cijrs 6x6 double[,] Cijrs = CombineCinpkTensorTermsIntoMatrix(Cinpk); #endregion constitutiveMatrix = Matrix.CreateFromArray(Cijrs); //PrintMethodsForDebug(KfpDq, f2_vectors, f3_vectors, KppDqVectors, f4_vectors, DqCondDq, d2W_dfdf, Cijrs); this.modified = CheckIfConstitutiveMatrixChanged(); }
public void CalculateOriginalConstitutiveMatrixWithoutNLAnalysis() { ISolver solver; if (matrices_not_initialized) { this.InitializeMatrices(); this.InitializeData(); solver = createSolver(model); solver.OrderDofs(false); //model.GlobalDofOrdering = solver.DofOrderer.OrderDofs(model); //TODO find out if new structures cause any problems foreach (ILinearSystem linearSystem in solver.LinearSystems.Values) { linearSystem.Reset(); linearSystem.Subdomain.Forces = Vector.CreateZero(linearSystem.Size); } this.InitializeFreeAndPrescribedDofsInitialDisplacementVectors(); } else { solver = createSolver(model); solver.OrderDofs(false); //v2.1. TODO: Is this needed in this case? foreach (ILinearSystem linearSystem in solver.LinearSystems.Values) { linearSystem.Reset(); } //solver.ResetSubdomainForcesVector(); } trueStressVec = new double[3]; var elementProvider = new ElementStructuralStiffnessProvider(); #region INTEGRATION constitutive Matrix var integrationSimultaneous = new SubdomainCalculationsAndAssembly(); (Dictionary <int, double[][]> KfpDqSubdomains, Dictionary <int, double[][]> KppDqVectorsSubdomains) = integrationSimultaneous.UpdateSubdomainKffAndCalculateKfpDqAndKppDqpMultipleObje(model, elementProvider, scaleTransitions, boundaryNodes, boundaryElements, solver); Dictionary <int, double[][]> f2_vectorsSubdomains = SubdomainCalculationsMultiple.CalculateKffinverseKfpDqSubdomains(KfpDqSubdomains, model, elementProvider, scaleTransitions, boundaryNodes, solver); Dictionary <int, double[][]> f3_vectorsSubdomains = SubdomainCalculationsMultiple.CalculateKpfKffinverseKfpDqSubdomains(f2_vectorsSubdomains, model, elementProvider, scaleTransitions, boundaryNodes); double[][] f3_vectors = SubdomainCalculationsMultiple.CombineMultipleSubdomainsIntegrationVectorsIntoTotal(f3_vectorsSubdomains, scaleTransitions); double[][] KppDqVectors = SubdomainCalculationsMultiple.CombineMultipleSubdomainsIntegrationVectorsIntoTotal(KppDqVectorsSubdomains, scaleTransitions); double[][] f4_vectors = SubdomainCalculations.SubtractConsecutiveVectors(KppDqVectors, f3_vectors); double[,] DqCondDq = SubdomainCalculations.CalculateDqCondDq(f4_vectors, scaleTransitions, boundaryNodes); double[,] constitutiveMat = new double[DqCondDq.GetLength(0), DqCondDq.GetLength(1)]; for (int i1 = 0; i1 < DqCondDq.GetLength(0); i1++) { for (int i2 = 0; i2 < DqCondDq.GetLength(1); i2++) { constitutiveMat[i1, i2] = (1 / volume) * DqCondDq[i1, i2]; } } #endregion #region constitutive tensors transformation methods // transformation gia to shell (var transformedTrueStressVec, var transformedConstitutiveMat) = StressesAndConstitutiveMatrixTransformation(trueStressVec, constitutiveMat); this.constitutiveMatrix = Matrix.CreateFromArray(transformedConstitutiveMat); trueStressVec = transformedTrueStressVec; #endregion //PrintMethodsForDebug(KfpDq, f2_vectors, f3_vectors, KppDqVectors, f4_vectors, DqCondDq, d2W_dfdf, Cijrs); this.modified = CheckIfConstitutiveMatrixChanged(); if (EstimateOnlyLinearResponse) { model = null; boundaryElements = null; boundaryNodes = null; NormalVectorV3 = null; TangentVectorV1 = null; TangentVectorV2 = null; rveBuilder = null; uInitialFreeDOFDisplacementsPerSubdomain = null; initialConvergedBoundaryDisplacements = null; trueStressVec = null; transformationMatrix = null; Cijrs_prev = null; } }